heat_tree_pq()
because {metacoder} package is archived from CRAN.build_tree_pq
to resubmit to CRAN
Add a param return_a_vector
in function filter_trim()
to make possible to return a vector of path as it is usefull when used with targets::tar_targets(..., format="file")
)list()
by vector(list, ...)
CRAN 2024-09-09
filter_taxa_blast()
for filter_asv_blast()
postcluster_pq()
for asv2otu()
return_data_for_venn
in function ggvenn_pq
in order to make more customizable plot following ggVennDiagram tutorialrename_asv
by rename_taxons
in clean_pq()
reorder_asv
by reorder_taxons
in clean_pq()
default_fun
in function merge_samples2()
in order to replace the default function that change the sample data in case of merging. A useful parameter is default_fun=diff_fct_diff_class
.kruskal_test
to hill_pq()
function to prevent user to mis-interpret Tuckey HSD result (and letters) if the global effect of the tested factor on Hill diversity is non significant.vioplot
to hill_pq() function to allow violin plot instead of boxplot.rarefy_sample_count_by_modality
to debug the case of modality with level of length one.CRAN 2024-04-28
taxa_as_rows()
and taxa_as_columns()
to replace verbose called to clean_pq()
ggscatt_pq()
to plot and test for effect of a numerical columns in sam_data on Hill number. Its the equivalent for numerical variables of ggbetween_pq()
which focus on the effect of a factor. var_par_pq()
, var_par_rarperm_pq()
and plot_var_part_pq()
to compute the partition of the variation of community and plot it. It introduce the notion of rarperm
part in the function name. It refers to the fact that this function compute permutation of samples depth rarefaction to measure the variation due to the random process in rarefaction. hill_test_rarperm_pq()
to test the effect of a factor on hill diversity accounting for the variation due to random nature of the rarefaction by sample depth. rarefy_sample_count_by_modality()
to equalize the number of samples for each levels of a modality (factor)accu_plot_balanced_modality()
to plot accumulation curves with balanced modality (same number of samples per level) and depth rarefaction (same number of sequences per sample) adonis_rarperm_pq()
to compute multiple Permanova analyses on different sample depth rarefaction.ggaluv_pq()
to plot taxonomic distribution in alluvial fashion with ggplot2 (using the [ggalluvial] package)glmutli_pq()
to use automated model selection and multimodel inference with (G)LMs for phyloseq objecttaxa_ranks
in function psmelt_samples_pq()
to group results by samples AND taxonomic ranks. hill_scales
in functions hill_tuckey_pq()
and hill_p()
to choose the level of the hill number. na_remove
in function hill_pq()
to remove samples with NA in the factor fact.plot_with_tuckey
to hill_pq()
.,formattable_pq()
to make beautiful table of the distribution of taxa across a modality using visualization inside in the table.fac2col()
and transp()
to facilitate manipulation of colors, especially in function formattable_pq()
signif_ancombc()
and plot_ancombc_pq()
to plot significant results from ancombc_pq()
functiondistri_1_taxa()
to summarize the distribution of one given taxa across level of a modalitynormalize_prop_pq()
to implement the method proposed by McKnight et al. 2018psmelt_samples_pq()
to build data frame of samples information including the number of sequences (Abundance) and Hill diversity metrics. Useful to use with the ggstatsplot packages (see examples).variable
by fact
in function ggbetween_pq()
and hill_pq()
(keeping the variable option in hill_pq()
for backward compatibility)chimera_removal_vs()
. Now it return a matrix to be able to be parsed on to [dada2::getUniques()] CRAN 2024-03-08
chimera_detection_vs()
and chimera_removal_vs()
to process chimera detection and removal using vsearch software filter_trim()
, sample_data_with_new_names()
and rename_samples()
to facilitate the use of targets for bioinformatic pipeline.add_info_to_sam_data()
to expand sam_data slot using a data.frame and using nb_asv and nb_seq swarm_clustering()
and vsearch_clustering()
and add swarm
method in the function asv2otu()
physeq_or_string_to_dna()
mostly for internal usecutadapt_remove_primers()
to remove primers using cutadaptAdd internal functions is_swarm_installed()
, is_cutadapt_installed()
, is_vsearch_installed()
and is_falco_installed()
to test for the availability of external software in order to run examples and test from testthat.
Submit to CRAN and change code to comply with their rules (patch 0.7.1 to 0.7.9)
add_nb_sequences
-> add_nb_seq
in ggvenn_pq()
db
-> db_url
in get_funguild_db()
db
-> db_funguild
in get_funguild_db()
file
-> file_path
in get_file_extension()
n_seq
-> nb_seq
in subsample_fastq()
otutable
-> otu_table
in lulu()
alpha
-> pval
in plot_edgeR_pq()
and plot_deseq2_pq()
and change default value from 0.01 to more classical 0.05sequences
-> seq2search
in function search_exact_seq_pq()
seq_names
-> dna_seq
in function asv2otu
Removing the function install_pkg_needed()
which do not comply with CRAN policies
ancombc_pq()
to simplify the call to ANCOMBC::ancombc2()
: ANalysis of COmpositions of Microbiomes with Bias Correction 2 taxa_names_from_physeq
(default FALSE) to subset_taxa_pq()
rarefy_by_sample
(default FALSE) to function ggbetween_pq()
are_modality_even_depth()
to test if samples depth significantly vary among the modalities of a factormerge_taxa_vec()
and merge_samples2()
from the speedyseq package into MiscMetabar to decrease package dependencies (Thanks to Mike R. Mclaren)reorder_taxa_pq()
in order to replace the unique call to package MicroViz to decrease package dependencies.get_funguild_db()
and funguild_assign()
from the FUNGuildR package into MiscMetabar to decrease package dependencies goodpractice::gp
() and devtools::check()
functionverify_pq()
with args verbose=TRUE
multitax_bar_pq()
when using nb_seq = FALSE
ggbetween_pq()
to facilitate comparison of hill number using the power of ggstatsplot::ggbetweenstats()
plot_SCBD_pq()
to plot species contributions to beta diversity (SCBD) of samplesLCBD_pq()
and plot_LCBD_pq()
to compute, test and plot local contributions to beta diversity (LCBD) of samplestbl_sum_samdata()
to summarize information from sample data in a tablemumu_pq()
to use mumu, a fast and robust C++ implementation of lulu.install_pkg_needed()
to install pkg (mostly for package list in Suggest in DESCRIPTION) if needed by a function.add_funguild_info()
and plot_guild_pq()
to add and plot fungal guild information from taxonomy using FUNGuild
packagebuild_phytree_pq()
to build 3 phylogenetic trees (NJ, UPGMA and ML using phangorn
R package) from the refseq
slot of a phyloseq
object, possibly with bootstrap values. See the vignettes Tree visualization for an introduction to tree visualization using ggtree
R package.ggvenn_pq()
thanks to issue #31log_10
in function biplot_pq()
into log10trans
log10transform
in function circle_pq()
into log10trans
one_plot
(default FALSE, same behavior than before) to hill_pq
function in order to return an unique ggplot2 object with the four plots inside.correction_for_sample_size
(default TRUE, same behavior than before) to hill_pq
and hill_tuckey_pq
function to allow removing any correction for uneven sampling depth.multitax_bar_pq()
to plot 3 levels of taxonomy in function of samples attributesridges_pq()
to plot ridges of one taxonomic level in function of samples attributestreemap_pq
to plot treemap of two taxonomic levelsiNEXT_pq()
to calculate hill diversity using the iNEXT package.pairs
to multi_biplot_pq()
in order to indicate all pairs of samples we want to print.compare_pairs_pq()
with information about the number of shared sequences among pairs.upset_pq()
to plot upset of phyloseq object using the ComplexUpset package.upset_test_pq
to test for differences between intersections (wrapper of ComplexUpset::upset_test()
for phyloseq-object
).add_info
) in subtitle of the hill_pq()
function.remove_space
to simplify_taxo()
function.simplify_taxo
to clean_pq()
function.rarefy_nb_seq
by rarefy_before_merging
and add arguments rarefy_after_merging
and add_nb_seq
to ggvenn_pq()
function.rarefy_after_merging
to biplot_pq()
and upset_pq()
functions.taxa_fill
to upset_pq()
function in order to fill the bar with taxonomic rank.subsample_fastq()
to make subset of fastq files in order to test your pipeline with all samples but with a low number of reads.accu_samp_threshold()
to compute the number of sequence to obtain a given proportion of ASV in accumulation curves (`accu_plot).tax_bar_pq()
in order to plot taxonomic distribution across samples.multi_biplot_pq()
to visualize a collection of couples of samples for comparison through a list of biplot_pq()
.add_info
, na_remove
, and clean_pq
to plot_tax_pq()
function.vsearch_cluster_method
and vsearch_args
to otu2asv()
for more detailed control of the vsearch software.MM_idtaxa()
.write_pq()
called save_pq()
to save a phyloseq object in the three possible formats () at the same timeadd_blast_info()
to add information from blast_pq()
to the tax_table
slot of a phyloseq object.keep_temporary_files
in asv2otu()
function.asv2otu()
and fix a little bug in the name of the conserved ASV after asv2otu()
.search_exact_seq_pq()
to search for exact matching of sequences using complement, reverse and reverse-complement against a phyloseq object.add_new_taxonomy_pq()
to add new taxonomic rank to a phyloseq object. For example to add taxonomic assignment from a new database.test_that
package and improve code compatibility with cran recommendations.asv2otu()
with method="vsearch"
change two default values (to repeat the precedent behavior, use asv2otu(..., vsearch_cluster_method = "--cluster_fast", tax_adjust = 1)
): add_nb_samples
to ggvenn_pq()
which add the number of samples to level name in the plot. Useful to see disequilibrium in the number of samples among the factor's levels.args_makedb
and args_blastn
to functions blast_pq()
, blast_to_phyloseq()
, blast_to_derep()
and filter_asv_blast()
.rarefy_nb_seqs
to ggven_pq()
in order to rarefy samples before plotting. SRS_curve_pq()
to plot scaling with ranked subsampling (SRS) curves using the SRS::SRS_curve()
function (see citation("SRS") for reference).nb_samples_info
to biplot_pq()
in order to add the number of samples merged by level of factors.biplot_pq()
and ggvenn_pq()
.na_remove
, dist_method
(including Aitchinson and robust-Aitchinson distance), correction_for_sample_size
and rarefy_nb_seqs
options to adonis_pq()
function.na_remove
to graph_test_pq()
function.plot_tax_pq()
to plot taxonomic distribution (nb of sequences or nb of ASV) across factor.add_points
and make better axis of hill_pq()
functionblast_to_derep()
in order to facilitate searching some fasta sequences in dereplicated sequences (obtained by dada2::derepFastq
) | | Database (makeblastdb) | Sequences to blast (blastn) |
|-----------------------|------------------------------------------------|-----------------------------------|
| blast_to_phyloseq()
| Built from ref_seq
slot(physeq-class) | Custom fasta file |
| blast_to_derep()
| Built from dereplicate sequences (derep-class) | Custom fasta file |
| blast_pq()
| Custom database or custom fasta file | ref_seq
slot of a physeq object |
tsne_pq()
and plot_tsne_pq()
to quickly visualize results of the t-SNE multidimensional analysis based on the Rtsne::Rtsne()
function.count_seq()
track_wkflow_samples()
and select_one_sample()
sam_data_first
in function write_pq()
reorder_asv
and rename_asv
to in function write_pq()
and clean_pq
rotl_pq()
to build a phylogenetic tree using the ASV binomial names of a physeq object and the Open Tree of Life tree.split_by
to make multiple plot given a variable in sam_data
slot (function ggvenn_pq()
) seq_names
in asv2otu()
function allow to clusterize sequences from a character vector of DNA.blast_pq()
function to blast the sequences of the @ref_seq
slot against a custom databasefilter_asv_blast()
function to filter ASV in phyloseq dataset using blast against a custom databasesubset_taxa_pq()
function to filter ASV based on a named conditional vector. Used in filter_asv_blast()
.force_taxa_as_columns
(default FALSE) and force_taxa_as_rows
(default FALSE) to clean_pq()
.count_fastq_seq()
to count sequences from fastq.gz files directly from R.track_wkflow()
function (parameter taxonomy_rank
)physeq
by pk
.
\tabular{rl}{
graph_test_pq()
\tab now a synonym for physeq_graph_test
\cr
adonis_pq()
\tab now a synonym for adonis_phyloseq
\cr
clean_pq()
\tab now a synonym for clean_physeq
\cr
lulu_pq()
\tab now a synonym for lulu_phyloseq
\cr
circle_pq()
\tab now a synonym for otu_circle
\cr
biplot_pq()
\tab now a synonym for biplot_physeq
\cr
read_pq()
\tab now a synonym for read_phyloseq
\cr
write_pq()
\tab now a synonym for write_phyloseq
\cr
sankey_pq()
\tab now a synonym for sankey_phyloseq
\cr
summary_plot_pq()
\tab now a synonym for summary_plot_phyloseq
\cr
plot_edgeR_pq()
\tab now a synonym for plot_edgeR_phyloseq
\cr
plot_deseq2_pq()
\tab now a synonym for plot_deseq2_phyloseq
\cr
venn_pq()
\tab now a synonym for venn_phyloseq
\cr
ggvenn_pq()
\tab now a synonym for ggVenn_phyloseq
\cr
hill_tuckey_pq()
\tab now a synonym for hill_tuckey_phyloseq
\cr
hill_pq()
\tab now a synonym for hill_phyloseq
\cr
heat_tree_pq()
\tab now a synonym for physeq_heat_tree
\cr
compare_pairs_pq()
\tab now a synonym for multiple_share_bisamples
\cr
}sam_names()
to read_pq()
data_fungi
and data_fungi_sp_known
metadataAdapt the function asv2otu()
to IdClusters change in the DECIPHER package (commit 254100922f2093cc789d018c18a26752a3cda1e3). Then change the IdClusters function that was removed from DECIPHER to Clusterize function.
Better functioning of blast_to_phyloseq()
when none query sequences are founded.
Add tax_adjust argument to asv2otu()
function
Add some functions useful for the targets package
Add a biplot_physeq()
function to visualize of two samples for comparison of physeq object
Add an argument modality in the tax_datatable()
function to split OTU abundancy by level of the sample modality
Add a function multiple_share_bisamples()
to help compare samples by pairs
Add a new function (ggVenn_phyloseq()
) for better venn diagram but without area calculation (use venn_phyloseq()
in this case).
Add two functions helpful for beta-diversity analysis (adonis_phyloseq()
and physeq_graph_test()
)
Any scripts or data that you put into this service are public.
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.