R/process_import_qiime2.R
import_qiime2.RdImport the qiime2 artifacts, including feature table, taxonomic table, phylogenetic tree, representative sequence and sample metadata into phyloseq object.
import_qiime2(
otu_qza,
taxa_qza = NULL,
sam_tab = NULL,
refseq_qza = NULL,
tree_qza = NULL,
keep_taxa_rows = TRUE
)(Required). character, file path of the feature table from qiime2.
(Optional). character, file path of the taxonomic table from qiime2,
default NULL.
(Optional). character, file path of the sample metadata in tsv format,
default NULL.
(Optional). character, file path of the representative sequences from
qiime2, default NULL.
(Optional). character, file path of the phylogenetic tree from
qiime2, default NULL.
(Optional). logical. whether keep taxa in rows or not
in the otu_table of the returned phyloseq object, default TRUE.
phyloseq::phyloseq object.
if (FALSE) {
otuqza_file <- system.file(
"extdata", "table.qza",
package = "MicrobiomeAnalysis"
)
taxaqza_file <- system.file(
"extdata", "taxonomy.qza",
package = "MicrobiomeAnalysis"
)
sample_file <- system.file(
"extdata", "sample-metadata.tsv",
package = "MicrobiomeAnalysis"
)
treeqza_file <- system.file(
"extdata", "tree.qza",
package = "MicrobiomeAnalysis"
)
ps <- import_qiime2(
otu_qza = otuqza_file, taxa_qza = taxaqza_file,
sam_tab = sample_file, tree_qza = treeqza_file
)
ps
}