Title: | Data for the Fern Tree of Life (FTOL) |
---|---|
Description: | Provides the Fern Tree of Life (FTOL) phylogeny and related data files. |
Authors: | Joel Nitta [aut, cre] |
Maintainer: | Joel Nitta <[email protected]> |
License: | MIT + file LICENSE |
Version: | 1.7.0 |
Built: | 2024-10-30 07:16:02 UTC |
Source: | https://github.com/fernphy/ftolr |
One row per accession.
accessions_long
accessions_long
A tibble (data frame) with 14965 rows and 8 columns.
Species name; matches names of tips in tree
Name of locus (gene or intergenic spacer region)
GenBank accession number
Sequence length (bp), excluding any missing or ambiguous bases
Scientific name used in FTOL
Scientific name used in the NCBI taxonomic database
NCBI taxonomy database unique identifier
Logical; TRUE for outgroup taxa, FALSE for ingroup taxa (ferns)
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
One row per species.
accessions_wide
accessions_wide
A tibble (data frame) with 5615 rows and 13 columns.
Species name; matches names of tips in tree
GenBank accession number for atpA
GenBank accession number for atpB
GenBank accession number for matK
GenBank accession number for rbcL
GenBank accession number for rps4
GenBank accession number for rps4-trnS
GenBank accession number for trnL-trnF
GenBank accession number for plastomes
Method used to join loci
Specimen voucher
Publication
Logical; TRUE for outgroup taxa, FALSE for ingroup taxa (ferns)
join_by
only provided for Sanger (non-plastome) sequences.
specimen_voucher
and publication
only provided for Sanger
(non-plastome) sequences, and only if these were the same across all loci.
specimen_voucher
has been converted to lower case, alpha-numeric
characters only to account for orthographic variation in GenBank data.
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Majority-rule extended consensus phylogenetic tree inferred from whole fern plastomes by maximum-likelihood, including maximal sampling of available species on GenBank.
backbone_tree
backbone_tree
List of class "phylo"
Includes 504 tips and 503 internal nodes. Branch lengths are in units of estimated genetic change per site (not ultrametric). Node labels are bootstrap support (%).
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
con_fossils
was used for the consensus tree; ml_fossils
was used for the
ML tree.
con_fossils ml_fossils
con_fossils ml_fossils
A tibble (data frame) with 54 rows and 12 columns.
Unique ID number for fossil
Minimum age to apply to fossil constraint
Node calibrated by fossil constraint. Combination of 'affinities' and 'affinities_group'
Taxonomic name of fossil (without author)
Type of group the fossil belongs to (crown or stem)
Narrowest clade the fossil belongs to; the clade whose date is constrained by the fossil
Are the affinities monophyletic? 'Yes', 'No', or 'Monotypic'
Number of tips in the clade constrained by the fossil
Node number of MRCA for the clade constrained by the fossil
Node number of the parent node of the MRCA for the clade constrained by the fossil
Name of one taxon that defines the clade constrained by the fossil
Name of another taxon that defines the clade constrained by the fossil
An object of class spec_tbl_df
(inherits from tbl_df
, tbl
, data.frame
) with 54 rows and 12 columns.
The fossils in con_fossils
and ml_fossils
are generally the same, but the
node each calibrates may differ between the trees because of differences in
topology. Also, in some cases, a given fossil may only be applied to the ML
or consensus tree (not both) because the topology of the tree makes that
fossil redundant with another fossil.
The node corresponding to the fossil constraint is defined as the most recent common ancestor (MRCA, column 'mrca') of two tips columns ('tip_1' and 'tip_2') for crown affinities, or its parent node (column 'stem_mrca') for stem affinities. The two tips are identified automatically for monophyletic clades, or by hand for non-monophyletic clades. 'mrca' is not defined for monotypic groups (only 'stem_mrca').
Does not include the constraint on the root of the tree.
For further details on methods used for molecular dating, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Current Fern Tree of Life (FTOL) version and related metadata
ft_data_ver(what = "ftol")
ft_data_ver(what = "ftol")
what |
Character vector of length 1; what type of data to return. Must choose from "ftol" (FTOL data version; default), "gb" (version of GenBank data used to build FTOL), or "cutoff" (cutoff date of GenBank data). |
FTOL is built from DNA sequence data obtained from the NCBI GenBank FTP server (https://ftp.ncbi.nlm.nih.gov/genbank/), which releases updated datasets periodically. For more information about the current GenBank data release, see the release notes.
Character vector of length 1
ft_data_ver()
ft_data_ver()
For details about the data, see plastome_alignment for plastome sequences and sanger_alignment for Sanger sequences.
ft_seqs( loci = NULL, plastome = FALSE, aligned = TRUE, del_gaps = ifelse(is.null(loci), FALSE, TRUE), drop_og = FALSE )
ft_seqs( loci = NULL, plastome = FALSE, aligned = TRUE, del_gaps = ifelse(is.null(loci), FALSE, TRUE), drop_og = FALSE )
loci |
Character vector (optional); names of loci to include in the
output. If |
plastome |
Logical vector of length 1; If |
aligned |
Logical vector of length 1; If |
del_gaps |
Logical vector of length 1; If |
drop_og |
Logical vector of length 1; If |
After subsetting loci, columns / rows consisting of only gaps
will be deleted regardless of del_gaps
argument (del_gaps
deletes all
gaps, typically resulting in unaligned sequences).
For details on methods used to assemble alignments, see Nitta et al. 2022.
List or matrix of class "DNAbin"; DNA sequences.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
# Default is aligned Sanger sequences ft_seqs()
# Default is aligned Sanger sequences ft_seqs()
For details on methods used to infer the tree, see Nitta et al. 2022.
ft_tree( branch_len = "ultra", consensus = TRUE, rooted = TRUE, backbone = FALSE, drop_og = FALSE, label_ages = FALSE, decimals = NULL )
ft_tree( branch_len = "ultra", consensus = TRUE, rooted = TRUE, backbone = FALSE, drop_og = FALSE, label_ages = FALSE, decimals = NULL )
branch_len |
Character vector of length 1; how to treat branch lengths.
Must choose from |
consensus |
Logical vector of length 1; if |
rooted |
Logical vector of length 1; if |
backbone |
Logical vector of length 1; if |
drop_og |
Logical vector of length 1; if |
label_ages |
Logical vector of length 1; if |
decimals |
Numeric vector of length 1; number of decimals for rounding
node labels if |
Not all combinations are possible. For example, branch_len = "ultra"
is
only available if backbone = FALSE
.
List of class "phylo"; a phylogenetic tree.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
# Default is the consensus tree with branchlengths in units of time ft_tree()
# Default is the consensus tree with branchlengths in units of time ft_tree()
Majority-rule extended consensus phylogenetic tree of ferns inferred from seven loci by maximum-likelihood and dated using 60 fossil ferns as constraints, including maximal sampling of available species on GenBank.
ftol_con_dated_tree
ftol_con_dated_tree
List of class "phylo"
A backbone phylogeny based on full plastome sequences including 503 tips was first inferred and used as a constraint tree for the consensus tree.
Includes 5,610 tips and 5,609 internal nodes. Branch lengths are in units of time (Ma). Node labels are bootstrap support (BS) values (%).
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Majority-rule extended consensus phylogenetic tree of ferns inferred from seven loci by maximum-likelihood, including maximal sampling of available species on GenBank.
ftol_con_tree
ftol_con_tree
List of class "phylo"
A backbone phylogeny based on full plastome sequences including 503 tips was first inferred and used as a constraint tree for the consensus tree.
Includes 5,611 tips and 5,610 internal nodes. Branch lengths are in units of estimated genetic change per site (not ultrametric). Node labels are bootstrap support (BS) values (%).
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Fern species names included in FTOL in alphabetical order. All species names are unique. Includes 5592 species.
ftol_ferns
ftol_ferns
Character vector
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Results of taxonomic name matching and resolution for species included in
FTOL. Original names from the NCBI taxonomic database
(https://www.ncbi.nlm.nih.gov/taxonomy) were matched to those in pteridocat
(https://github.com/fernphy/pteridocat), and synonyms resolved to their
accepted names in pteridocat. For compact printing, it is recommended to use
the tibble
library (library(tibble)
).
ftol_match_results
ftol_match_results
A tibble (data frame) with 6476 rows and 7 columns.
Queried taxonomic name from NCBI
Resolved name used in FTOL
Name matching query in pteridocat
Taxonomic status of resolved name
Taxonomic status of matched name
Type of match assigned by taxontools
NCBI taxonomic ID
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Pteridophyte Phylogeny Group I (2016) A community-derived classification for extant lycophytes and ferns. Journal of Systematics and Evolution 54:563–603. https://doi.org/10.1111/jse.12229
A maximum-likelihood (ML) phylogenetic tree of ferns inferred from seven loci and dated using fossil ferns as constraints, including maximal sampling of available species on GenBank.
ftol_ml_dated_tree
ftol_ml_dated_tree
List of class "phylo"
A backbone phylogeny based on full plastome sequences including 503 tips was first inferred and used as a constraint tree for the ML tree.
Includes 5,610 tips and 5,609 internal nodes. Branch lengths are in units of time (Ma). Node labels are bootstrap support (BS) values (%) separated by a forward slash. BS value before the slash is BS calculated from the full (Sanger) sampling; BS value after the slash is BS calculated from the backbone (plastome) sampling.
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
A maximum-likelihood (ML) phylogenetic tree of ferns inferred from seven loci, including maximal sampling of available species on GenBank.
ftol_ml_tree
ftol_ml_tree
List of class "phylo"
A backbone phylogeny based on full plastome sequences including 503 tips was first inferred and used as a constraint tree for the ML tree.
Includes 5,611 tips and 5,610 internal nodes. Branch lengths are in units of estimated genetic change per site (not ultrametric). Node labels are bootstrap support (BS) values (%) separated by a forward slash. BS value before the slash is BS calculated from the full (Sanger) sampling; BS value after the slash is BS calculated from the backbone (plastome) sampling.
For details on methods used to infer the tree, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Taxonomic data for species included in FTOL. For compact printing, it is
recommended to use the tibble
library (library(tibble)
).
ftol_taxonomy
ftol_taxonomy
A tibble (data frame) with 5611 rows and 8 columns.
Species name
Genus name
Subfamily name
Family name
Suborder name
Order name
Informal higher level clade name, either order or suborder
Logical; TRUE for outgroup taxa, FALSE for ingroup taxa (ferns)
Taxonomy follows Pteridophyte Phylogeny Group I (2016).
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Pteridophyte Phylogeny Group I (2016) A community-derived classification for extant lycophytes and ferns. Journal of Systematics and Evolution 54:563–603. https://doi.org/10.1111/jse.12229
Concatenation of 79 loci from whole fern plastomes, including maximal sampling of available species on GenBank.
plastome_alignment
plastome_alignment
Matrix of class "DNAbin"
Includes 504 species and 75,413 bases.
For details on methods used to assemble alignment, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
These data can be used to extract portions of the plastome DNA sequence alignment (plastome_alignment) corresponding to individual loci.
plastome_parts
plastome_parts
A tibble (data frame) with 79 rows and 3 columns.
Name of locus (gene or intergenic spacer region)
Start position (column number) of locus in concatenated DNA alignment
End position (column number) of locus in concatenated DNA alignment
For details on methods used to assemble alignment, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
Concatenation of 7 loci primarily obtained from Sanger sequencing, including maximal sampling of available species on GenBank.
sanger_alignment
sanger_alignment
Matrix of class "DNAbin"
Includes 5,611 species and 12,648 bases.
For details on methods used to assemble alignment, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768
These data can be used to extract portions of the Sanger DNA sequence alignment (sanger_alignment) corresponding to individual loci.
sanger_parts
sanger_parts
A tibble (data frame) with 7 rows and 3 columns.
Name of locus (gene or intergenic spacer region)
Start position (column number) of locus in concatenated DNA alignment
End position (column number) of locus in concatenated DNA alignment
For details on methods used to assemble alignment, see Nitta et al. 2022.
Nitta JH, Schuettpelz E, Ramírez-Barahona S, Iwasaki W. (2022) An open and continuously updated fern tree of life. https://doi.org/10.3389/fpls.2022.909768