lefser is the R implementation of the Linear discriminant analysis (LDA) Effect Size (LEfSe), a Python package for metagenomic biomarker discovery and explanation. (Huttenhower et al. 2011).
The original software utilizes standard statistical significance tests along with supplementary tests that incorporate biological consistency and the relevance of effects to identity the features (e.g., organisms, clades, OTU, genes, or functions) that are most likely to account for differences between the two sample classes of interest. While LEfSe is widely used and available in different platform such as Galaxy UI and Conda, there is no convenient way to incorporate it in R-based workflows. Thus, we re-implement LEfSe as an R/Bioconductor package, lefser. Following the LEfSe‘s algorithm including Kruskal-Wallis test, Wilcoxon-Rank Sum test, and Linear Discriminant Analysis, with some modifications, lefser successfully reproduces and improves the original statistical method and the associated plotting functionality.
if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
BiocManager::install("lefser")library(lefser)Your citations are crucial in keeping our software free and open source. To cite our package, please use this publication at the link here.
lefser package include the demo dataset, zeller14, which is the
microbiome data from colorectal cancer (CRC) patients and controls
(Zeller et al. 2014).
In this vignette, we excluded the ‘adenoma’ condition and used control/CRC as the main classes and age category as sub-classes (adult vs. senior) with different numbers of samples: control-adult (n = 46), control-senior (n = 20), CRC-adult (n = 45), and CRC-senior (n = 46).
data(zeller14)
zeller14 <- zeller14[, zeller14$study_condition != "adenoma"]The class and subclass information is stored in the colData slot under the
study_condition and age_category columns, respectively.
## Contingency table
table(zeller14$age_category, zeller14$study_condition)#>         
#>          CRC control
#>   adult   45      46
#>   senior  46      20If you try to run lefser directly on the ‘zeller14’ data, you will get the
following warning messages
lefser(zeller14, classCol = "study_condition", subclassCol = "age_category")Warning messages:
1: In lefser(zeller14, classCol = "study_condition", subclassCol = "age_category") :
  Convert counts to relative abundances with 'relativeAb()'
2: In lda.default(x, classing, ...) : variables are collinearWhen working with taxonomic data, including both terminal and non-terminal nodes in the analysis can lead to collinearity problems. Non-terminal nodes (e.g., genus) are often linearly dependent on their corresponding terminal nodes (e.g., species) since the species-level information is essentially a subset or more specific representation of the genus-level information. This collinearity can violate the assumptions of certain statistical methods, such as linear discriminant analysis (LDA), and can lead to unstable or unreliable results. By using only terminal nodes, you can effectively eliminate this collinearity issue, ensuring that your analysis is not affected by linearly dependent or highly correlated variables. Additionally, you can benefit of avoiding redundancy, increasing specificity, simplifying data, and reducing ambiguity, using only terminal nodes.
You can select only the terminal node using get_terminal_nodes function.
tn <- get_terminal_nodes(rownames(zeller14))
zeller14tn <- zeller14[tn,]First warning message informs you that lefser requires relative abundance of
features. You can use relativeAb function to reformat your input.
zeller14tn_ra <- relativeAb(zeller14tn)lefserThe lefser function returns a data.frame with two columns - the names of
selected features (the features column) and their effect size (the scores
column).
There is a random number generation step in the lefser algorithm to ensure
that more than half of the values for each features are unique. In most cases,
inputs are sparse, so in practice, this step is handling 0s. So to reproduce
the identical result, you should set the seed before running lefser.
set.seed(1234)
res <- lefser(zeller14tn_ra, # relative abundance only with terminal nodes
              classCol = "study_condition",
              subclassCol = "age_category")
head(res)#>                                                                                                                                                                             features
#> 1                                                        k__Bacteria|p__Firmicutes|c__Clostridia|o__Clostridiales|f__Oscillospiraceae|g__Oscillibacter|s__Oscillibacter_unclassified
#> 2                            k__Bacteria|p__Firmicutes|c__Clostridia|o__Clostridiales|f__Peptostreptococcaceae|g__Peptostreptococcus|s__Peptostreptococcus_stomatis|t__GCF_000147675
#> 3 k__Bacteria|p__Bacteroidetes|c__Bacteroidia|o__Bacteroidales|f__Porphyromonadaceae|g__Porphyromonas|s__Porphyromonas_asaccharolytica|t__Porphyromonas_asaccharolytica_unclassified
#> 4                           k__Bacteria|p__Firmicutes|c__Clostridia|o__Clostridiales|f__Clostridiaceae|g__Clostridium|s__Clostridium_symbiosum|t__Clostridium_symbiosum_unclassified
#> 5                                                         k__Bacteria|p__Firmicutes|c__Bacilli|o__Bacillales|f__Bacillales_noname|g__Gemella|s__Gemella_morbillorum|t__GCF_000185645
#> 6            k__Bacteria|p__Fusobacteria|c__Fusobacteriia|o__Fusobacteriales|f__Fusobacteriaceae|g__Fusobacterium|s__Fusobacterium_nucleatum|t__Fusobacterium_nucleatum_unclassified
#>      scores
#> 1 -3.336170
#> 2 -2.941230
#> 3 -2.834329
#> 4 -2.706471
#> 5 -2.579108
#> 6 -2.431915lefserPlotlefserPlot(res)The codes for benchmarking lefser against LEfSe and the other R implementation of LEfSe is available here.
When using phyloseq objects, we recommend to extract the data and create a
SummarizedExperiment object as follows:
library(phyloseq)
library(SummarizedExperiment)
## Load phyloseq object
fp <- system.file("extdata", 
                  "study_1457_split_library_seqs_and_mapping.zip",
                  package = "phyloseq")
kostic <- microbio_me_qiime(fp)#> Found biom-format file, now parsing it... 
#> Done parsing biom... 
#> Importing Sample Metdadata from mapping file...
#> Merging the imported objects... 
#> Successfully merged, phyloseq-class created. 
#>  Returning...## Split data tables
counts <- unclass(otu_table(kostic))
coldata <- as(sample_data(kostic), "data.frame")
## Create a SummarizedExperiment object
SummarizedExperiment(assays = list(counts = counts), colData = coldata)#> class: SummarizedExperiment 
#> dim: 2505 190 
#> metadata(0):
#> assays(1): counts
#> rownames(2505): 304309 469478 ... 206906 298806
#> rowData names(0):
#> colnames(190): C0333.N.518126 C0333.T.518046 ... 32I9UNA9.518098
#>   BFJMKNMP.518102
#> colData names(71): X.SampleID BarcodeSequence ... HOST_TAXID
#>   DescriptionYou may also consider using makeTreeSummarizedExperimentFromPhyloseq from
the mia package.
mia::makeTreeSummarizedExperimentFromPhyloseq(kostic)#> class: TreeSummarizedExperiment 
#> dim: 2505 190 
#> metadata(0):
#> assays(1): counts
#> rownames(2505): 304309 469478 ... 206906 298806
#> rowData names(7): Kingdom Phylum ... Genus Species
#> colnames(190): C0333.N.518126 C0333.T.518046 ... 32I9UNA9.518098
#>   BFJMKNMP.518102
#> colData names(71): X.SampleID BarcodeSequence ... HOST_TAXID
#>   Description
#> reducedDimNames(0):
#> mainExpName: NULL
#> altExpNames(0):
#> rowLinks: NULL
#> rowTree: NULL
#> colLinks: NULL
#> colTree: NULLsessionInfo()#> R version 4.5.0 RC (2025-04-04 r88126)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 24.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.21-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.0
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_GB              LC_COLLATE=C              
#>  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
#>  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
#>  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
#> [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
#> 
#> time zone: America/New_York
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] phyloseq_1.52.0             lefser_1.18.0              
#>  [3] SummarizedExperiment_1.38.0 Biobase_2.68.0             
#>  [5] GenomicRanges_1.60.0        GenomeInfoDb_1.44.0        
#>  [7] IRanges_2.42.0              S4Vectors_0.46.0           
#>  [9] BiocGenerics_0.54.0         generics_0.1.3             
#> [11] MatrixGenerics_1.20.0       matrixStats_1.5.0          
#> [13] BiocStyle_2.36.0           
#> 
#> loaded via a namespace (and not attached):
#>   [1] libcoin_1.0-10                  jsonlite_2.0.0                 
#>   [3] MultiAssayExperiment_1.34.0     magrittr_2.0.3                 
#>   [5] estimability_1.5.1              TH.data_1.1-3                  
#>   [7] modeltools_0.2-23               ggbeeswarm_0.7.2               
#>   [9] magick_2.8.6                    farver_2.1.2                   
#>  [11] rmarkdown_2.29                  ragg_1.4.0                     
#>  [13] fs_1.6.6                        vctrs_0.6.5                    
#>  [15] multtest_2.64.0                 DelayedMatrixStats_1.30.0      
#>  [17] ggtree_3.16.0                   tinytex_0.57                   
#>  [19] BiocBaseUtils_1.10.0            htmltools_0.5.8.1              
#>  [21] S4Arrays_1.8.0                  BiocNeighbors_2.2.0            
#>  [23] cellranger_1.1.0                Rhdf5lib_1.30.0                
#>  [25] SparseArray_1.8.0               rhdf5_2.52.0                   
#>  [27] gridGraphics_0.5-1              parallelly_1.43.0              
#>  [29] sass_0.4.10                     bslib_0.9.0                    
#>  [31] plyr_1.8.9                      DECIPHER_3.4.0                 
#>  [33] sandwich_3.1-1                  testthat_3.2.3                 
#>  [35] emmeans_1.11.0                  zoo_1.8-14                     
#>  [37] cachem_1.1.0                    igraph_2.1.4                   
#>  [39] lifecycle_1.0.4                 iterators_1.0.14               
#>  [41] pkgconfig_2.0.3                 rsvd_1.0.5                     
#>  [43] Matrix_1.7-3                    R6_2.6.1                       
#>  [45] fastmap_1.2.0                   GenomeInfoDbData_1.2.14        
#>  [47] digest_0.6.37                   aplot_0.2.5                    
#>  [49] ggnewscale_0.5.1                colorspace_2.1-1               
#>  [51] patchwork_1.3.0                 scater_1.36.0                  
#>  [53] irlba_2.3.5.1                   textshaping_1.0.0              
#>  [55] vegan_2.6-10                    beachmat_2.24.0                
#>  [57] labeling_0.4.3                  httr_1.4.7                     
#>  [59] TreeSummarizedExperiment_2.16.0 abind_1.4-8                    
#>  [61] mgcv_1.9-3                      compiler_4.5.0                 
#>  [63] withr_3.0.2                     BiocParallel_1.42.0            
#>  [65] viridis_0.6.5                   DBI_1.2.3                      
#>  [67] MASS_7.3-65                     DelayedArray_0.34.0            
#>  [69] bluster_1.18.0                  biomformat_1.36.0              
#>  [71] permute_0.9-7                   tools_4.5.0                    
#>  [73] vipor_0.4.7                     beeswarm_0.4.0                 
#>  [75] ape_5.8-1                       glue_1.8.0                     
#>  [77] nlme_3.1-168                    rhdf5filters_1.20.0            
#>  [79] gridtext_0.1.5                  grid_4.5.0                     
#>  [81] mia_1.16.0                      cluster_2.1.8.1                
#>  [83] reshape2_1.4.4                  ade4_1.7-23                    
#>  [85] gtable_0.3.6                    tzdb_0.5.0                     
#>  [87] fillpattern_1.0.2               tidyr_1.3.1                    
#>  [89] hms_1.1.3                       data.table_1.17.0              
#>  [91] xml2_1.3.8                      BiocSingular_1.24.0            
#>  [93] ScaledMatrix_1.16.0             coin_1.4-3                     
#>  [95] XVector_0.48.0                  ggrepel_0.9.6                  
#>  [97] foreach_1.5.2                   pillar_1.10.2                  
#>  [99] stringr_1.5.1                   yulab.utils_0.2.0              
#> [101] splines_4.5.0                   ggtext_0.1.2                   
#> [103] dplyr_1.1.4                     treeio_1.32.0                  
#> [105] lattice_0.22-7                  survival_3.8-3                 
#> [107] DirichletMultinomial_1.50.0     tidyselect_1.2.1               
#> [109] SingleCellExperiment_1.30.0     Biostrings_2.76.0              
#> [111] scuttle_1.18.0                  knitr_1.50                     
#> [113] gridExtra_2.3                   bookdown_0.43                  
#> [115] xfun_0.52                       brio_1.1.5                     
#> [117] rbiom_2.2.0                     stringi_1.8.7                  
#> [119] UCSC.utils_1.4.0                lazyeval_0.2.2                 
#> [121] ggfun_0.1.8                     yaml_2.3.10                    
#> [123] evaluate_1.0.3                  codetools_0.2-20               
#> [125] tibble_3.2.1                    BiocManager_1.30.25            
#> [127] ggplotify_0.1.2                 cli_3.6.4                      
#> [129] systemfonts_1.2.2               xtable_1.8-4                   
#> [131] munsell_0.5.1                   jquerylib_0.1.4                
#> [133] readxl_1.4.5                    Rcpp_1.0.14                    
#> [135] coda_0.19-4.1                   parallel_4.5.0                 
#> [137] readr_2.1.5                     ggplot2_3.5.2                  
#> [139] sparseMatrixStats_1.20.0        slam_0.1-55                    
#> [141] decontam_1.28.0                 viridisLite_0.4.2              
#> [143] mvtnorm_1.3-3                   tidytree_0.4.6                 
#> [145] scales_1.3.0                    purrr_1.0.4                    
#> [147] crayon_1.5.3                    rlang_1.1.6                    
#> [149] multcomp_1.4-28