Skip to content

Commit

Permalink
DOC: drop link to sina community tutorial (#537)
Browse files Browse the repository at this point in the history
  • Loading branch information
nbokulich authored Aug 19, 2022
1 parent aec9610 commit 7eb8169
Showing 1 changed file with 7 additions and 7 deletions.
14 changes: 7 additions & 7 deletions source/tutorials/phylogeny.rst
Original file line number Diff line number Diff line change
Expand Up @@ -119,14 +119,15 @@ plugin.

*Reference based alignments*

There are a variety of tools such as `PyNAST`_) (using `NAST`_), `Infernal`_,
and `SINA`_, etc., that attempt to reduce the amount of ambiguously aligned
regions by using curated reference alignments (e.g. `SILVA`_. Reference
There are several tools that attempt to reduce the amount of ambiguously aligned
regions by using curated reference alignments. Traditional, de novo alignment methods mututally align a set of unaligned sequences to create a multiple sequence alignment (MSA) from scratch. Re-running these methods with additional sequences will create MSAs with varying numbers of columns and assignments of bases to each column. These alignments is therefore incompatible with one another and may not be joined through concatenation.

Reference based alignments, on the other hand, are meant to add sequences to an existing alignment. Alignments computed using reference based alignment tools always have widths identical to the reference alignment and maintain the meaning of each column. Therefore, these alignments may be concatenated.

QIIME 2 currently does not wrap any methods for reference-based alignments, but alignments created using these methods can be imported into QIIME 2 as ``FeatureData[AlignedSequence]`` artifacts, provided that the alignments are standard FASTA formats. Some examples of tools for reference-based alignment include `PyNAST`_ (using `NAST`_), `Infernal`_, and `SINA`_. `SILVA`_ Reference
alignments are particularly powerful for rRNA gene sequence data, as knowledge
of secondary structure is incorporated into the curation process, thus
increasing alignment quality. For a more in-depth and eloquent overview of
reference-based alignment approaches, check out the great `SINA community
tutorial`_).
increasing alignment quality.

.. note:: Alignments constructed using reference based alignment approaches can
be masked too, just like the above MAFFT example. Also, the reference
Expand Down Expand Up @@ -587,7 +588,6 @@ This can all be accomplished by simply running the following:
.. _Infernal: https://doi.org/10.1093/bioinformatics/btt509
.. _SINA: https://doi.org/10.1093/bioinformatics/bts252
.. _SILVA: https://www.arb-silva.de/
.. _SINA community tutorial: https://forum.qiime2.org/t/q2-alignment-reference-based-alignment-using-sina/6220
.. _Phylogeny for the faint of heart - a tutorial: http://doi.org/10.1016/S0168-9525(03)00112-4
.. _Molecular phylogenetics - principles and practice: http://dx.doi.org/10.1038/nrg3186
.. _Phylogenetics - An Introduction: https://www.ebi.ac.uk/training/online/course/introduction-phylogenetics
Expand Down

0 comments on commit 7eb8169

Please sign in to comment.