msaClustalOmega: Multiple Sequence Alignment with ClustalOmega

Description Usage Arguments Details Value Author(s) References See Also Examples

View source: R/msaClustalOmega.R

Description

This function calls the multiple sequence alignment algorithm ClustalOmega.

Usage

1
2
3
4
5
    msaClustalOmega(inputSeqs, cluster="default",
                    gapOpening="default", gapExtension="default",
                    maxiters="default",  substitutionMatrix="default",
                    type="default", order=c("aligned", "input"),
                    verbose=FALSE, help=FALSE, ...) 

Arguments

inputSeqs

input sequences; see msa. In the original ClustalOmega implementation, this parameter is called infile.

cluster

The cluster size which should be used. The default is 100. In the original ClustalOmega implementation, this parameter is called cluster-size.

gapOpening,gapExtension

ClustalOmega currently does not allow to adjust gap penalties; these arguments are only for future extensions and consistency with the other algorithms and msa. However, setting these parameters to values other than "default" will result in a warning.

maxiters

maximum number of iterations; the default value is 0 (no limitation). In the original ClustalOmega implementation, this parameter is called iterations.

substitutionMatrix

name of substitution matrix for scoring matches and mismatches; can be one of the choices "BLOSUM30", "BLOSUM40", "BLOSUM50", "BLOSUM65", "BLOSUM80", and "Gonnet". This parameter is a new feature - the original ClustalOmega implementation does not allow for using a custom substitution matrix.

type

type of the input sequences inputSeqs; see msa.

order

how the sequences should be ordered in the output object (see msa); in the original ClustalW implementation, this parameter is called output-order.

verbose

if TRUE, the algorithm displays detailed information and progress messages.

help

if TRUE, information about algorithm-specific parameters is displayed. In this case, no multiple sequence alignment is performed and the function quits after displaying the additional help information.

...

further parameters specific to ClustalOmega; An overview of parameters that are available in this interface is shown when calling msaClustalOmega with help=TRUE. For more details, see also the documentation of ClustalOmega.

Details

This is a function providing the ClustalOmega multiple alignment algorithm as an R function. It can be used for various types of sequence data (see inputSeqs argument above). Parameters that are common to all multiple sequences alignments provided by the msa package are explicitly provided by the function and named in the same for all algorithms. Most other parameters that are specific to ClustalOmega can be passed to ClustalOmega via additional arguments (see argument help above).

Since ClustalOmega only allows for using built-in amino acid substitution matrices, it is hardly useful for multiple alignments of nucleotide sequences.

For a note on the order of output sequences and direct reading from FASTA files, see msa.

Value

Depending on the type of sequences for which it was called, msaClustalOmega returns a MsaAAMultipleAlignment, MsaDNAMultipleAlignment, or MsaRNAMultipleAlignment object. If called with help=TRUE, msaClustalOmega returns an invisible NULL.

Author(s)

Enrico Bonatesta and Christoph Horejs-Kainrath <msa@bioinf.jku.at>

References

http://www.bioinf.jku.at/software/msa

U. Bodenhofer, E. Bonatesta, C. Horejs-Kainrath, and S. Hochreiter (2015). msa: an R package for multiple sequence alignment. Bioinformatics 31(24):3997-3999. DOI: 10.1093/bioinformatics/btv494.

http://www.clustal.org/omega/README

Sievers, F., Wilm, A., Dineen, D., Gibson, T. J., Karplus, K., Li, W., Lopez, R., McWilliam, H., Remmert, M., Soeding, J., Thompson, J. D., and Higgins, D. G. (2011) Fast, scalable generation of high-quality protein multiple sequence alignments using Clustal Omega. Mol. Syst. Biol. 7:539. DOI: 10.1038/msb.2011.75.

See Also

msa, MsaAAMultipleAlignment, MsaDNAMultipleAlignment, MsaRNAMultipleAlignment, MsaMetaData

Examples

 1
 2
 3
 4
 5
 6
 7
 8
 9
10
## read sequences
filepath <- system.file("examples", "exampleAA.fasta", package="msa")
mySeqs <- readAAStringSet(filepath)

## call msaClustalOmega with default values
msaClustalOmega(mySeqs)

## call msaClustalOmega with custom parameters
msaClustalOmega(mySeqs, auto=FALSE, cluster=120, dealign=FALSE,
                useKimura=FALSE, order="input", verbose=FALSE)

Example output

Loading required package: Biostrings
Loading required package: BiocGenerics
Loading required package: parallel

Attaching package:BiocGenericsThe following objects are masked frompackage:parallel:

    clusterApply, clusterApplyLB, clusterCall, clusterEvalQ,
    clusterExport, clusterMap, parApply, parCapply, parLapply,
    parLapplyLB, parRapply, parSapply, parSapplyLB

The following objects are masked frompackage:stats:

    IQR, mad, sd, var, xtabs

The following objects are masked frompackage:base:

    anyDuplicated, append, as.data.frame, basename, cbind, colnames,
    dirname, do.call, duplicated, eval, evalq, Filter, Find, get, grep,
    grepl, intersect, is.unsorted, lapply, Map, mapply, match, mget,
    order, paste, pmax, pmax.int, pmin, pmin.int, Position, rank,
    rbind, Reduce, rownames, sapply, setdiff, sort, table, tapply,
    union, unique, unsplit, which.max, which.min

Loading required package: S4Vectors
Loading required package: stats4

Attaching package:S4VectorsThe following object is masked frompackage:base:

    expand.grid

Loading required package: IRanges
Loading required package: XVector

Attaching package:BiostringsThe following object is masked frompackage:base:

    strsplit

using Gonnet
ClustalOmega 1.2.0 

Call:
   msaClustalOmega(mySeqs)

MsaAAMultipleAlignment with 9 rows and 467 columns
    aln                                                    names
[1] MSALVLESRALGRKLSDFGQETSYIE...LKI-LADSISSEVEILCSALQKLK- PH4H_Bos_taurus
[2] MSTAVLENPGLGRKLSDFGQETSYIE...LKI-LADSINSEIGILCSALQKIK- PH4H_Homo_sapiens
[3] MAAVVLENGVLSRKLSDFGQETSYIE...LKI-LADSINSEVGILCNALQKIKS PH4H_Rattus_norve...
[4] MAAVVLENGVLSRKLSDFGQETSYIE...LKI-LADSINSEVGILCHALQKIKS PH4H_Mus_musculus
[5] --------------------------...------------------------- PH4H_Pseudomonas_...
[6] --------------------------...------------------------- PH4H_Rhizobium_loti
[7] --------------------------...YATAGGRLAGAAAG----------- PH4H_Caulobacter_...
[8] --------------------------...GWADTEDV----------------- PH4H_Chromobacter...
[9] --------------------------...GWADTADI----------------- PH4H_Ralstonia_so...
Con --------------------------...???-?AD???????----------- Consensus 
using Gonnet
ClustalOmega 1.2.0 

Call:
   msaClustalOmega(mySeqs, auto = FALSE, cluster = 120, dealign = FALSE,     useKimura = FALSE, order = "input", verbose = FALSE)

MsaAAMultipleAlignment with 9 rows and 467 columns
    aln                                                    names
[1] MSTAVLENPGLGRKLSDFGQETSYIE...LKI-LADSINSEIGILCSALQKIK- PH4H_Homo_sapiens
[2] MAAVVLENGVLSRKLSDFGQETSYIE...LKI-LADSINSEVGILCNALQKIKS PH4H_Rattus_norve...
[3] MAAVVLENGVLSRKLSDFGQETSYIE...LKI-LADSINSEVGILCHALQKIKS PH4H_Mus_musculus
[4] --------------------------...GWADTEDV----------------- PH4H_Chromobacter...
[5] --------------------------...------------------------- PH4H_Pseudomonas_...
[6] MSALVLESRALGRKLSDFGQETSYIE...LKI-LADSISSEVEILCSALQKLK- PH4H_Bos_taurus
[7] --------------------------...GWADTADI----------------- PH4H_Ralstonia_so...
[8] --------------------------...YATAGGRLAGAAAG----------- PH4H_Caulobacter_...
[9] --------------------------...------------------------- PH4H_Rhizobium_loti
Con --------------------------...???-?AD???????----------- Consensus 

msa documentation built on Nov. 8, 2020, 5:41 p.m.