Title: | Feature Extraction from Biological Sequences |
---|---|
Description: | Extracts features from biological sequences. It contains most features which are presented in related work and also includes features which have never been introduced before. It extracts numerous features from nucleotide and peptide sequences. Each feature converts the input sequences to discrete numbers in order to use them as predictors in machine learning models. There are many features and information which are hidden inside a sequence. Utilizing the package, users can convert biological sequences to discrete models based on chosen properties. References: 'iLearn' 'Z. Chen et al.' (2019) <DOI:10.1093/bib/bbz041>. 'iFeature' 'Z. Chen et al.' (2018) <DOI:10.1093/bioinformatics/bty140>. <https://CRAN.R-project.org/package=rDNAse>. 'PseKRAAC' 'Y. Zuo et al.' 'PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition' (2017) <DOI:10.1093/bioinformatics/btw564>. 'iDNA6mA-PseKNC' 'P. Feng et al.' 'iDNA6mA-PseKNC: Identifying DNA N6-methyladenosine sites by incorporating nucleotide physicochemical properties into PseKNC' (2019) <DOI:10.1016/j.ygeno.2018.01.005>. 'I. Dubchak et al.' 'Prediction of protein folding class using global description of amino acid sequence' (1995) <DOI:10.1073/pnas.92.19.8700>. 'W. Chen et al.' 'Identification and analysis of the N6-methyladenosine in the Saccharomyces cerevisiae transcriptome' (2015) <DOI:10.1038/srep13859>. |
Authors: | Sare Amerifar |
Maintainer: | Sare Amerifar <[email protected]> |
License: | GPL-3 |
Version: | 2.0.0 |
Built: | 2024-11-08 06:38:22 UTC |
Source: | CRAN |
This function transforms an amino acid to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
AA2Binary( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
AA2Binary( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*20. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-AA2Binary(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-AA2Binary(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This function converts the amino acids of a sequence to a list of physicochemical properties in the aaIndex file. For each amino acid, the function uses a numeric vector which shows the aaIndex of the amino acid.
AAindex( seqs, selectedAAidx = 1:554, standardized = TRUE, threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
AAindex( seqs, selectedAAidx = 1:554, standardized = TRUE, threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
selectedAAidx |
AAindex function works based on physicochemical properties. Users select the properties by their ids or indexes in aaIndex2 file. |
standardized |
is a logical parameter. If it is set to TRUE, amino acid indices will be in the standard format. The default value is TRUE. |
threshold |
is a number between (0 , 1]. In selectedAAidx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
In this function each amino acid is converted to a numeric vector. Elements of the vector represent a physicochemical property for the amino acid. In the aaIndex database, there are 554 amino acid indices. Users can choose the desired aaindex by specifying aaindexes through their ids or indexes in the aaIndex file, via selectedAAidx parameter.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*(number of selected amino acid indexes) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-AAindex(seqs = ptmSeqsVect, selectedAAidx=1:5,outFormat="mat") ad<-paste0(dir,"/aaidx.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") AAindex(seqs = filePrs, selectedAAidx=1:5,standardized=TRUE,threshold=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-AAindex(seqs = ptmSeqsVect, selectedAAidx=1:5,outFormat="mat") ad<-paste0(dir,"/aaidx.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") AAindex(seqs = filePrs, selectedAAidx=1:5,standardized=TRUE,threshold=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
In this function, each sequence is divided into k equal partitions. The length of each part is equal to ceiling(l(lenght of the sequence)/k). The last part can have a different length containing the residual amino acids. The amino acid composition is calculated for each part.
AAKpartComposition(seqs, k = 3, normalized = TRUE, label = c())
AAKpartComposition(seqs, k = 3, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is an integer value. Each sequence should be divided to k partition(s). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
a feature matrix with k*20 number of columns. The number of rows is equal to the number of sequences.
Warning: The length of all sequences should be greater than k.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-AAKpartComposition(seqs=filePrs,k=5,normalized=FALSE)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-AAKpartComposition(seqs=filePrs,k=5,normalized=FALSE)
It creates the feature matrix for each function in autocorelation (i.e., Moran, Greay, NormalizeMBorto) or autocovariance (i.e., AC, CC,ACC). The user can select any combination of the functions too. In this case, the final matrix will contain features of each selected function.
AAutoCor( seqs, selectedAAidx = list(c("CIDH920105", "BHAR880101", "CHAM820101", "CHAM820102", "CHOC760101", "BIGC670101", "CHAM810101", "DAYM780201")), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
AAutoCor( seqs, selectedAAidx = list(c("CIDH920105", "BHAR880101", "CHAM820101", "CHAM820102", "CHOC760101", "BIGC670101", "CHAM810101", "DAYM780201")), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
selectedAAidx |
Function takes as input the physicochemical properties. Users select the properties by their ids or indices in the aaIndex2 file. This parameter could be a vector or a list of amino acid indices. The default values of the vector are the 'CIDH920105','BHAR880101','CHAM820101','CHAM820102','CHOC760101','BIGC670101','CHAM810101','DAYM780201' ids in the aaIndex2 file. |
maxlag |
This parameter shows the maximum gap between two amino acids. The gaps change from 1 to maxlag (the maximum lag). |
threshold |
is a number between (0 , 1]. In selectedAAidx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
type |
could be 'Moran', 'Greay', 'NormalizeMBorto', 'AC', 'CC', or 'ACC'. Also, it could be any combination of them. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
For CC and AAC autocovriance functions, which consider the covariance of the two physicochemical properties, we have provided users with the ability to categorize their selected properties in a list. The binary combination of each group will be taken into account. Note: If all the features are in a group or selectedAAidx parameter is a vector, the binary combination will be calculated for all the physicochemical properties.
This function returns a feature matrix. The number of columns in the matrix changes depending on the chosen autocorrelation or autocovariance types and nlag parameter. The output is a matrix. The number of rows shows the number of sequences.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-AAutoCor(seqs=filePrs,maxlag=20,threshold=0.9, type=c("Moran","Geary","NormalizeMBorto","AC")) mat2<-AAutoCor(seqs=filePrs,maxlag=20,threshold=0.9,selectedAAidx= list(c('CIDH920105','BHAR880101','CHAM820101','CHAM820102'),c('CHOC760101','BIGC670101') ,c('CHAM810101','DAYM780201')),type=c("AC","CC","ACC"))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-AAutoCor(seqs=filePrs,maxlag=20,threshold=0.9, type=c("Moran","Geary","NormalizeMBorto","AC")) mat2<-AAutoCor(seqs=filePrs,maxlag=20,threshold=0.9,selectedAAidx= list(c('CIDH920105','BHAR880101','CHAM820101','CHAM820102'),c('CHOC760101','BIGC670101') ,c('CHAM810101','DAYM780201')),type=c("AC","CC","ACC"))
This function replace each amino acid of the sequence with a three-dimensional vector. Values are taken from the three hidden units of the neural network trained on structure alignments. The AESNN3 function can be applied to encode peptides of equal length.
AESNN3(seqs, label = c(), outFormat = "mat", outputFileDist = "")
AESNN3(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*(5) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes.
Lin K, May AC, Taylor WR. Amino acid encoding schemes from protein structure alignments: multi-dimensional vectors to describe residue types. J Theor Biol (2002).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-AESNN3(seqs = ptmSeqsVect,outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-AESNN3(seqs = ptmSeqsVect,outFormat="mat")
This function checks the alphabets in a sequence. If one of the following conditions hold, the sequence will be deleted: 1. A peptide sequence containing non-standard amino acids, 2. A DNA sequence with an alphabet other than A, C, G, or T, 3. An RNA sequence having an alphabet other than A, C, G, or U.
alphabetCheck(sequences, alphabet = "aa", label = c())
alphabetCheck(sequences, alphabet = "aa", label = c())
sequences |
is a string vector. Each element is a peptide, protein, DNA, or RNA sequences. |
alphabet |
This parameter shows the alphabet of sequences. If it is set to 'aa', it indicates the alphabet of amino acids. When it is 'dna', it shows the nucleotide alphabet and in case it equals 'rna', it represents ribonucleotide alphabet. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
'alphabetCheck' returns a list with two elements. The first element is a vector which contains valid sequences. The second element is a vector which contains the labels of the sequences (if any exists).
This function receives a sequence vector and the label of sequences (if any). It deletes sequences (and their labels) containing non-standard alphabets.
seq<-alphabetCheck(sequences=c("AGDFLIAACNMLKIVYT","ADXVGAJK"),alphabet="aa")
seq<-alphabetCheck(sequences=c("AGDFLIAACNMLKIVYT","ADXVGAJK"),alphabet="aa")
This function replaces nucleotides with a four-length vector. The first three elements represent the nucleotides and the forth holds the frequency of the nucleotide from the beginning of the sequence until the position of the nucleotide in the sequence. 'A' will be replaced with c(1, 1, 1, freq), 'C' with c(0, 1, 0, freq),'G' with c(1, 0, 0, freq), and 'T' with c(0, 0, 1, freq).
ANF_DNA(seqs, outFormat = "mat", outputFileDist = "", label = c())
ANF_DNA(seqs, outFormat = "mat", outputFileDist = "", label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*(4) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Chen, W., Tran, H., Liang, Z. et al. Identification and analysis of the N6-methyladenosine in the Saccharomyces cerevisiae transcriptome. Sci Rep 5, 13859 (2015).
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-ANF_DNA(seqs = LNC50Nuc,outFormat="mat")
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-ANF_DNA(seqs = LNC50Nuc,outFormat="mat")
This function replaces ribonucleotides with a four-length vector. The first three elements represent the ribonucleotides and the forth holds the frequency of the ribonucleotide from the beginning of the sequence until the position of the ribonucleotide in the sequence. 'A' will be replaced with c(1, 1, 1, freq), 'C' with c(0, 1, 0, freq),'G' with c(1, 0, 0, freq), and 'U' with c(0, 0, 1, freq).
ANF_RNA(seqs, outFormat = "mat", outputFileDist = "", label = c())
ANF_RNA(seqs, outFormat = "mat", outputFileDist = "", label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*(4) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Chen, W., Tran, H., Liang, Z. et al. Identification and analysis of the N6-methyladenosine in the Saccharomyces cerevisiae transcriptome. Sci Rep 5, 13859 (2015).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-ANF_RNA(seqs = fileLNC,outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-ANF_RNA(seqs = fileLNC,outFormat="mat")
This function calculates the amphiphilic pseudo amino acid composition (Series) for each sequence.
APAAC( seqs, aaIDX = c("ARGP820101", "HOPT810101"), lambda = 30, w = 0.05, l = 1, threshold = 1, label = c() )
APAAC( seqs, aaIDX = c("ARGP820101", "HOPT810101"), lambda = 30, w = 0.05, l = 1, threshold = 1, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
aaIDX |
is a vector of Ids or indexes of the user-selected physicochemical properties in the aaIndex2 database. The default values of the vector are the hydrophobicity ids and hydrophilicity ids in the amino acid index file. |
lambda |
is a tuning parameter. Its value indicates the maximum number of spaces between amino acid pairs. The number changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in from 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 20^l elements of the APAAC descriptor. |
threshold |
is a number between (0 , 1]. In aaIDX, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo amino acid composition for each physicochemical property. We have provided users with the ability to choose among different properties (i.e., not confined to hydrophobicity or hydrophilicity).
A feature matrix such that the number of columns is 20^l+(number of chosen aaIndex*lambda) and the number of rows equals the number of sequences.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-APAAC(seqs=filePrs,l=2,lambda=3,threshold=1)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-APAAC(seqs=filePrs,l=2,lambda=3,threshold=1)
This function calculates the amphiphilic pseudo k nucleotide composition(Di) (Series) for each sequence.
APkNUCdi_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
APkNUCdi_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of dinucleotides. Users can choose the desired indices by their ids or their names in the DI_DNA index file. The default value of this parameter is a vector with ("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist") ids. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between dinucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in the range of 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l elements of the APkNCdi descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 to 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo nucleotide composition for each physicochemical property of dinucleotides. We have provided users with the ability to choose among the 148 properties in the di-nucleotide index database.
It is a feature matrix. The number of columns is 4^l+(number of the chosen indices*lambda) and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-APkNUCdi_DNA(seqs=fileLNC,ORF=TRUE,threshold=1)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-APkNUCdi_DNA(seqs=fileLNC,ORF=TRUE,threshold=1)
This function calculates the amphiphilic pseudo k ribonucleotide composition(Di) (Series) for each sequence.
APkNUCdi_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
APkNUCdi_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of di-ribonucleotides. Users can choose the desired indices by their ids or their names in the DI_RNA index file. The default value of this parameter is a vector with ("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)","Twist (RNA)") ids. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between di-ribonucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in the range of 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l elements of the APkNCdi descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 to 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo ribonucleotide composition for each physicochemical property of di-ribonucleotides. We have provided users with the ability to choose among the 22 properties in the di-ribonucleotide index database.
It is a feature matrix. The number of columns is 4^l+(number of the chosen indices*lambda) and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-APkNUCdi_RNA(seqs=fileLNC,ORF=TRUE,threshold=0.8)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-APkNUCdi_RNA(seqs=fileLNC,ORF=TRUE,threshold=0.8)
This function calculates the amphiphilic pseudo k nucleotide composition(Tri) (Series) for each sequence.
APkNUCTri_DNA( seqs, selectedIdx = c("Dnase I", "Bendability (DNAse)"), lambda = 3, w = 0.05, l = 3, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
APkNUCTri_DNA( seqs, selectedIdx = c("Dnase I", "Bendability (DNAse)"), lambda = 3, w = 0.05, l = 3, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of trinucleotides. Users can choose the desired indices by their ids or their names in the TRI_DNA index file. The default value of the parameter is a vector with ("Dnase I", "Bendability (DNAse)") ids. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between trinucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in the range of 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l of the APkNCTri descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo nucleotide composition for each physicochemical property of trinucleotides. We have provided users with the ability to choose among the 12 properties in the tri-nucleotide index database.
It is a feature matrix. The number of columns is 4^l+(number of the chosen indices*lambda) and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-APkNUCTri_DNA(seqs=fileLNC,l=3,threshold=1)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-APkNUCTri_DNA(seqs=fileLNC,l=3,threshold=1)
ASA represents an amino acid by a numeric value. This function extracts the ASA from the output of SPINE-X software which predicts ASA for each amino acid in a peptide or protein sequence. The output of SPINE-X is a tab-delimited file. ASAs are in the 11th column of the file.
ASA(dirPath, outFormat = "mat", outputFileDist = "")
ASA(dirPath, outFormat = "mat", outputFileDist = "")
dirPath |
Path of the directory which contains all output files of SPINE-X. Each file belongs to a sequence. |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
The output depends on the outFormat which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same lengths such that the number of columns is equal to the length of the sequences and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() ad<-paste0(dir,"/asa.txt") PredASAdir<-system.file("testForder",package="ftrCOOL") PredASAdir<-paste0(PredASAdir,"/ASAdir/") ASA(PredASAdir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ad<-paste0(dir,"/asa.txt") PredASAdir<-system.file("testForder",package="ftrCOOL") PredASAdir<-paste0(PredASAdir,"/ASAdir/") ASA(PredASAdir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This descriptor sufficiently considers the correlation information present not only between adjacent residues but also between intervening residues. This function calculates frequency of pair amino acids omitting gaps between them. Then this function normalizes each value through dividing each frequency by summition(frequencies).
ASDC(seqs, label = c())
ASDC(seqs, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 400 (all posible amino acid pairs).
Wei L, Zhou C, Chen H, Song J, Su R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-ASDC(seqs=filePrs)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-ASDC(seqs=filePrs)
This descriptor sufficiently considers the correlation information present not only between adjacent nucleotides but also between intervening nucleotides This function calculates frequency of pair nucleotides omitting gaps between them. Then this function normalizes each value through dividing each frequency by summition(frequencies).
ASDC_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
ASDC_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 16 (All posible nucleotide pairs).
Wei L, Zhou C, Chen H, Song J, Su R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") fileLNC<-fa.read(file=fileLNC,alphabet="dna")[1:5] mat1<-ASDC_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") fileLNC<-fa.read(file=fileLNC,alphabet="dna")[1:5] mat1<-ASDC_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This descriptor sufficiently considers the correlation information present not only between adjacent ribo ribonucleotides but also between intervening nucleotides This function calculates frequency of pair ribonucleotides omitting gaps between them. Then this function normalizes each value through dividing each frequency by summition(frequencies).
ASDC_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
ASDC_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 16 (All posible ribonucleotide pairs).
Wei L, Zhou C, Chen H, Song J, Su R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") fileLNC<-fa.read(file=paste0(ptmSeqsADR,"/testSeq2RNA51.txt"),alphabet="rna") mat1<-ASDC_RNA(seqs=fileLNC)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") fileLNC<-fa.read(file=paste0(ptmSeqsADR,"/testSeq2RNA51.txt"),alphabet="rna") mat1<-ASDC_RNA(seqs=fileLNC)
It creates the feature matrix for each function in autocorelation (i.e., Moran, Greay, NormalizeMBorto) or autocovariance (i.e., AC, CC,ACC). The user can select any combination of the functions too. In this case, the final matrix will contain features of each selected function.
AutoCorDiNUC_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
AutoCorDiNUC_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
function takes as input the physicochemical properties. Users select the properties by their ids or indices in the DI_DNA file. This parameter could be a vector or a list of dinucleotide indices. The default value of this parameter is a vector with ("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist") ids. |
maxlag |
This parameter shows the maximum gap between two dinucleotide pairs. The gaps change from 1 to maxlag (the maximum lag). |
threshold |
is a number between (0 to 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted.The default value is 1. |
type |
could be 'Moran', 'Greay', 'NormalizeMBorto', 'AC', 'CC', or 'ACC'. Also, it could be any combination of them. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
For CC and AAC autocovriance functions, which consider the covariance of the two physicochemical properties, we have provided users with the ability to categorize their selected properties in a list. The binary combination of each group will be taken into account. Note: If all the features are in a group or selectedAAidx parameter is a vector, the binary combination will be calculated for all the physicochemical properties.
This function returns a feature matrix. The number of columns in the matrix changes depending on the chosen autocorrelation or autocovariance types and nlag parameter. The output is a matrix. The number of rows shows the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat2<-AutoCorDiNUC_DNA(seqs=fileLNC,selectedIdx=list(10,c(1,3),6:13,c(2:7)) ,maxlag=15,type="CC")
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat2<-AutoCorDiNUC_DNA(seqs=fileLNC,selectedIdx=list(10,c(1,3),6:13,c(2:7)) ,maxlag=15,type="CC")
It creates the feature matrix for each function in autocorelation (i.e., Moran, Greay, NormalizeMBorto) or autocovariance (i.e., AC, CC,ACC). The user can select any combination of the functions too. In this case, the final matrix will contain features of each selected function.
AutoCorDiNUC_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
AutoCorDiNUC_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
seqs |
is a FASTA file containing ribonucleic acid(RNA) sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a RNA sequence. |
selectedIdx |
function takes as input the physicochemical properties. Users select the properties by their ids or indices in the DI_RNA file. This parameter could be a vector or a list of di-ribonucleic acid indices. The default value of this parameter is a vector with ("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)","Twist (RNA)") ids. |
maxlag |
This parameter shows the maximum gap between two di-ribonucleotide pairs. The gaps change from 1 to maxlag (the maximum lag). |
threshold |
is a number between (0 to 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted.The default value is 1. |
type |
could be 'Moran', 'Greay', 'NormalizeMBorto', 'AC', 'CC', or 'ACC'. Also, it could be any combination of them. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
For CC and AAC autocovriance functions, which consider the covariance of the two physicochemical properties, we have provided users with the ability to categorize their selected properties in a list. The binary combination of each group will be taken into account. Note: If all the features are in a group or selectedAAidx parameter is a vector, the binary combination will be calculated for all the physicochemical properties.
This function returns a feature matrix. The number of columns in the matrix changes depending on the chosen autocorrelation or autocovariance types and nlag parameter. The output is a matrix. The number of rows shows the number of sequences.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") fileLNC<-fa.read(fileLNC,alphabet="rna") fileLNC<-fileLNC[1:20] mat1<-AutoCorDiNUC_RNA(seqs=fileLNC,maxlag=20,type=c("Moran"))
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") fileLNC<-fa.read(fileLNC,alphabet="rna") fileLNC<-fileLNC[1:20] mat1<-AutoCorDiNUC_RNA(seqs=fileLNC,maxlag=20,type=c("Moran"))
It creates the feature matrix for each function in autocorelation (i.e., Moran, Greay, NormalizeMBorto) or autocovariance (i.e., AC, CC,ACC). The user can select any combination of the functions too. In this case, the final matrix will contain features of each selected function.
AutoCorTriNUC_DNA( seqs, selectedNucIdx = c("Dnase I", "Bendability (DNAse)"), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
AutoCorTriNUC_DNA( seqs, selectedNucIdx = c("Dnase I", "Bendability (DNAse)"), maxlag = 3, threshold = 1, type = c("Moran", "Geary", "NormalizeMBorto", "AC", "CC", "ACC"), label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedNucIdx |
function takes as input the physicochemical properties. Users select the properties by their ids or indices in the TRI_DNA file. This parameter could be a vector or a list of trinucleotide indices. The default value of this parameter is a vector with ("Dnase I", "Bendability (DNAse)") ids. |
maxlag |
This parameter shows the maximum gap between two tri-nucleotide pairs. The gaps change from 1 to maxlag (the maximum lag). |
threshold |
is a number between (0 to 1]. In selectedNucIdx, indices with a correlation higher than the threshold will be deleted.The default value is 1. |
type |
could be 'Moran', 'Greay', 'NormalizeMBorto', 'AC', 'CC', or 'ACC'. Also, it could be any combination of them. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
For CC and AAC autocovriance functions, which consider the covariance of the two physicochemical properties, we have provided users with the ability to categorize their selected properties in a list. The binary combination of each group will be taken into account. Note: If all the features are in a group or selectedAAidx parameter is a vector, the binary combination will be calculated for all the physicochemical properties.
This function returns a feature matrix. The number of columns in the matrix changes depending on the chosen autocorrelation or autocovariance types and nlag parameter. The output is a matrix. The number of rows shows the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat1<-AutoCorTriNUC_DNA(seqs=fileLNC,selectedNucIdx=c(1:7),maxlag=20,type=c("Moran","Geary")) mat2<-AutoCorTriNUC_DNA(seqs=fileLNC,selectedNucIdx=list(c(1,3),6:10,c(2:7)), maxlag=15,type=c("AC","CC"))
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat1<-AutoCorTriNUC_DNA(seqs=fileLNC,selectedNucIdx=c(1:7),maxlag=20,type=c("Moran","Geary")) mat2<-AutoCorTriNUC_DNA(seqs=fileLNC,selectedNucIdx=list(c(1,3),6:10,c(2:7)), maxlag=15,type=c("AC","CC"))
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T1( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T1( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T1(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T1(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T2( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T2( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T2(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T2(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T3( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T3( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T3(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T3(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T4( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T4( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T4(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T4(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T5( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T5( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T5(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T5(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T6( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T6( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T6(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T6(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This group of functions(binary_3bit_T1-T7) categorizes amino acids in 3 groups based on the type. Then represent group of amino acids by a three dimentional vector. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_3bit_T7( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_3bit_T7( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T7(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_3bit_T7(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This function categorizes amino acids in 5 groups. Then represent group of amino acids by a 5 dimentional vector i.e.e1, e2, e3, e4, e5. e1=G, A, V, L, M, I, e2=F, Y, W, e3=K, R, H, e4=D, E, e5=S, T, C, P, N, Q. e1 is ecoded by 10000 e2 is encoded by 01000 and ... and e5 is encoded by 00001.
binary_5bit_T1( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_5bit_T1( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*5. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_5bit_T1(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_5bit_T1(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
The idea behind this function is: We have 20 amino acids and we can show them with at least 5 bits. A is encoded by (00011), C (00101), D (00110), E (00111), F(01001), G (01010), H (01011), I (01100), K (01101), L (01110), M (10001), N (10010), P (10011), Q (10100), R (10101), S (10110), T (11000), V (11001), W (11010), Y (11100). This function transforms an amino acid to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
binary_5bit_T2( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_5bit_T2( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*5. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_5bit_T2(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_5bit_T2(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This function categorizes amino acids in 6 groups. Then represent group of amino acids by a 6 dimentional vector i.e.e1, e2, e3, e4, e5, e6. e1=H, R, K, e2=D, E, N, D, e3=C, e4=S, T, P, A, G, e5=M, I, L, V, e6=F, Y, W. e1 is ecoded by 100000 e2 is encoded by 010000 and ... and e6 is encoded by 000001.
binary_6bit( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
binary_6bit( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each amino acid is represented by a string containing 20 characters(0-1). For example, A = ALANIN = "1000000...0" 'logicBin'(logical value): Each amino acid is represented by a vector containing 20 logical entries. For example, A = ALANIN = c(T,F,F,F,F,F,F,...F) 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 20 numerals. For example, A = ALANIN = c(1,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*6. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_6bit(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-binary_6bit(seqs = ptmSeqsVect, binaryType="numBin",outFormat="mat")
This function creates a 20-dimentional numeric vector for each amino acid of a sequence. Each entry of the vector contains the similarity score of the amino acid with other amino acids including itself. The score is extracted from the Blosum62 matrix.
BLOSUM62(seqs, label = c(), outFormat = "mat", outputFileDist = "")
BLOSUM62(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*20 and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") filePr<-system.file("extdata/protein.fasta",package="ftrCOOL") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") ad<-paste0(dir,"/blosum62.txt") vect<-BLOSUM62(seqs = filePr,outFormat="mat") BLOSUM62(seqs = filePrs,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") filePr<-system.file("extdata/protein.fasta",package="ftrCOOL") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") ad<-paste0(dir,"/blosum62.txt") vect<-BLOSUM62(seqs = filePr,outFormat="mat") BLOSUM62(seqs = filePrs,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function calculates the composition of k-spaced amino acid pairs. In other words, it computes the frequency of all amino acid pairs with k spaces.
CkSAApair(seqs, rng = 3, upto = FALSE, normalized = TRUE, label = c())
CkSAApair(seqs, rng = 3, upto = FALSE, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
rng |
This parameter can be a number or a vector. Each element of the vector shows the number of spaces between amino acid pairs. For each k in the rng vector, a new vector (whose size is 400) is created which contains the frequency of pairs with k gaps. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from [0 to rng]. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 400*(length of rng vector).
'upto' is enabled only when rng is a number and not a vector.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-CkSAApair(seqs=filePrs,rng=2,upto=TRUE,normalized=TRUE) mat2<-CkSAApair(seqs=filePrs,rng=c(1,3,5))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-CkSAApair(seqs=filePrs,rng=2,upto=TRUE,normalized=TRUE) mat2<-CkSAApair(seqs=filePrs,rng=c(1,3,5))
In this function, amino acids are first grouped into a category which is defined by the user. Later, the composition of the k-spaced grouped amino acids is computed. Please note that this function differs from CkSAApair which works on individual amino acids.
CkSGAApair( seqs, rng = 3, upto = FALSE, normalized = TRUE, Grp = "locFus", label = c() )
CkSGAApair( seqs, rng = 3, upto = FALSE, normalized = TRUE, Grp = "locFus", label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
rng |
This parameter can be a number or a vector. Each element of the vector shows the number of spaces between amino acid pairs. For each k in the rng vector, a new vector (whose size is (number of categorizes)^2) is created which contains the frequency of pairs with k gaps. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from [1 to rng]. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Column names in the feature matrix follow G(?ss?). For example, G(1ss2) means Group1**Group2, where '*' is a wild character.
This function returns a feature matrix. Row length is equal to the number of sequences and the number of columns is ((number of categorizes)^2)*(length of rng vector).
'upto' is enabled only when rng is a number and not a vector.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-CkSGAApair(seqs=filePrs,rng=2,upto=TRUE,Grp="aromatic") mat2<-CkSGAApair(seqs=filePrs,rng=c(1,3,5),upto=FALSE,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-CkSGAApair(seqs=filePrs,rng=2,upto=TRUE,Grp="aromatic") mat2<-CkSGAApair(seqs=filePrs,rng=c(1,3,5),upto=FALSE,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
This function calculates the composition of k-spaced nucleotide pairs. In other words, it computes the frequency of all nucleotide pairs with k spaces.
CkSNUCpair_DNA( seqs, rng = 3, upto = FALSE, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
CkSNUCpair_DNA( seqs, rng = 3, upto = FALSE, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
rng |
This parameter can be a number or a vector. Each element of the vector shows the number of spaces between nucleotide pairs. For each k in the rng vector, a new vector (whose size is 16) is created which contains the frequency of pairs with k gaps. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from [0 to rng]. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 16*(length of rng vector).
'upto' is enabled only when rng is a number and not a vector.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat1<-CkSNUCpair_DNA(seqs=fileLNC,rng=2,upto=TRUE,ORF=TRUE,reverseORF=FALSE) mat2<-CkSNUCpair_DNA(seqs=fileLNC,rng=c(1,3,5))
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat1<-CkSNUCpair_DNA(seqs=fileLNC,rng=2,upto=TRUE,ORF=TRUE,reverseORF=FALSE) mat2<-CkSNUCpair_DNA(seqs=fileLNC,rng=c(1,3,5))
This function calculates the composition of k-spaced ribonucleotide pairs. In other words, it computes the frequency of all ribonucleotide pairs with k spaces.
CkSNUCpair_RNA( seqs, rng = 3, upto = FALSE, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
CkSNUCpair_RNA( seqs, rng = 3, upto = FALSE, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
rng |
This parameter can be a number or a vector. Each element of the vector shows the number of spaces between ribonucleotide pairs. For each k in the rng vector, a new vector (whose size is 16) is created which contains the frequency of pairs with k gaps. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from [0 to rng]. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 16*(length of rng vector).
'upto' is enabled only when rng is a number and not a vector.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat1<-CkSNUCpair_RNA(seqs=fileLNC,rng=2,upto=TRUE,ORF=TRUE,reverseORF=FALSE) mat2<-CkSNUCpair_RNA(seqs=fileLNC,rng=c(1,3,5))
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat1<-CkSNUCpair_RNA(seqs=fileLNC,rng=2,upto=TRUE,ORF=TRUE,reverseORF=FALSE) mat2<-CkSNUCpair_RNA(seqs=fileLNC,rng=c(1,3,5))
This function calculates the codon adaption index for each sequence.
codonAdaptionIndex(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
codonAdaptionIndex(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature vector. The length of the vector is equal to the number of sequences. Each entry in the vector contains the value of the codon adaption index.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-codonAdaptionIndex(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-codonAdaptionIndex(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This function calculates the codon fraction for each sequence.
CodonFraction(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
CodonFraction(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A feature matrix such that the number of columns is 4^3 and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-CodonFraction(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-CodonFraction(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This function calculates the codon usage for each sequence.
CodonUsage_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
CodonUsage_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A feature matrix such that the number of columns is 4^3 and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-CodonUsage_DNA(fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-CodonUsage_DNA(fileLNC,ORF=TRUE,reverseORF=FALSE)
This function calculates the codon usage for each sequence.
CodonUsage_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
CodonUsage_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A feature matrix such that the number of columns is 4^3 and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-CodonUsage_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-CodonUsage_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This function calculates the grouped tripeptide composition with the conjoint triad grouping type.
conjointTriad(seqs, normalized = TRUE, label = c())
conjointTriad(seqs, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows equals to the number of sequences and the number of columns is 7^3.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-conjointTriad(seqs=filePrs)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-conjointTriad(seqs=filePrs)
This function calculates the grouped tripeptide composition with conjoint triad grouping type. For each k, it creates a 7^3 feature vector. K is the space between the first and the second amino acids and the second and the third amino acids of the tripeptide.
conjointTriadKS(seqs, rng = 3, upto = FALSE, normalized = FALSE, label = c())
conjointTriadKS(seqs, rng = 3, upto = FALSE, normalized = FALSE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
rng |
This parameter can be a number or a vector. Each element of the vector shows the number of spaces between the first and the second amino acids and the second and the third amino acids of the tripeptide. For each k in the rng vector, a new vector (whose size is 7^3) is created which contains the frequency of tri-amino acid with k gaps. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from 0 to rng. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A tripeptide with k spaces looks like AA1(ss..s)AA2(ss..s)AA3. AA stands for amino acids and s means space.
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (7^3)*(length rng vector).
'upto' is enabled only when rng is a number and not a vector.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-conjointTriadKS(filePrs,rng=2,upto=TRUE,normalized=TRUE) mat2<-conjointTriadKS(filePrs,rng=c(1,3,5))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-conjointTriadKS(filePrs,rng=2,upto=TRUE,normalized=TRUE) mat2<-conjointTriadKS(filePrs,rng=c(1,3,5))
This function calculates the composition, transition, and distribution for each sequence.
CTD(seqs, normalized = FALSE, label = c())
CTD(seqs, normalized = FALSE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Output is a combination of three different matrices: Composition, Transition, and Distribution. You can obtain any of the three matrices by executing the corresponding function, i.e., CTDC, CTDT, and CTDD.
Dubchak, Inna, et al. "Prediction of protein folding class using global description of amino acid sequence." Proceedings of the National Academy of Sciences 92.19 (1995): 8700-8704.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTDtotal<-CTD(seqs=filePrs,normalized=FALSE)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTDtotal<-CTD(seqs=filePrs,normalized=FALSE)
This function computes the composition part of CTD. Thirteen properties are defined in this function. Each property categorizes the amino acids of the sequences into three groups. The grouped amino acid composition is calculated for each property. For more information, please check the references.
CTDC(seqs, normalized = FALSE, label = c())
CTDC(seqs, normalized = FALSE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 3*7, where three is the number of groups and thirteen is the number of properties.
Dubchak, Inna, et al. "Prediction of protein folding class using global description of amino acid sequence." Proceedings of the National Academy of Sciences 92.19 (1995): 8700-8704.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTD_C<-CTDC(seqs=filePrs,normalized=FALSE,label=c())
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTD_C<-CTDC(seqs=filePrs,normalized=FALSE,label=c())
This function computes the distribution part of CTD. It calculates fifteen values for each property. For more information, please check the references.
CTDD(seqs, label = c())
CTDD(seqs, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 15*7.
Dubchak, Inna, et al. "Prediction of protein folding class using global description of amino acid sequence." Proceedings of the National Academy of Sciences 92.19 (1995): 8700-8704.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTD_D<-CTDD(seqs=filePrs)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTD_D<-CTDD(seqs=filePrs)
This function computes the transition part of CTD. Thirteen properties are defined in this function. Each property categorizes the amino acids of a sequence into three groups. For each property, the grouped amino acid transition (i.e., transitions 1-2, 1-3, and 2-3) is calculated. For more information, please check the references.
CTDT(seqs, normalized = FALSE, label = c())
CTDT(seqs, normalized = FALSE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 3*7, where three is the number of transition types (i.e., 1-2, 1-3, and 2-3) and thirteen is the number of properties.
Dubchak, Inna, et al. "Prediction of protein folding class using global description of amino acid sequence." Proceedings of the National Academy of Sciences 92.19 (1995): 8700-8704.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTD_T<-CTDT(seqs=filePrs,normalized=FALSE)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") CTD_T<-CTDT(seqs=filePrs,normalized=FALSE)
This function computes the dipeptide deviation from the expected mean value.
DDE(seqs, label = c())
DDE(seqs, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A feature matrix with 20^2=400 number of columns. The number of rows is equal to the number of sequences.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-DDE(seqs=filePrs)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-DDE(seqs=filePrs)
This function transforms a dinucleotide to a binary number with four bits which is enough to represent all the possible types of dinucleotides. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
DiNUC2Binary_DNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
DiNUC2Binary_DNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin' (String binary): each dinucleotide is represented by a string containing 4 characters(0-1). For example, AA = "0000" AC="0001" ... TT="1111" 'logicBin' (logical value): Each dinucleotide is represented by a vector containing 4 logical entries. For example, AA = c(F,F,F,F) AC=c(F,F,F,T) ... TT=c(T,T,T,T) 'numBin' (numeric bin): Each dinucleotide is represented by a numeric (i.e., integer) vector containing 4 numeric entries. For example, AA = c(0,0,0,0) AC = c(0,0,0,1) ... TT = c(1,1,1,1) |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the (length of the sequences-1). Otherwise, it is equal to (length of the sequences-1)*4. If outFormat is 'txt', all binary values will be written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-DiNUC2Binary_DNA(seqs = LNC50Nuc, binaryType="numBin",outFormat="mat")
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-DiNUC2Binary_DNA(seqs = LNC50Nuc, binaryType="numBin",outFormat="mat")
This function transforms a di-ribonucleotide to a binary number with four bits which is enough to represent all the possible types of di-ribonucleotides. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
DiNUC2Binary_RNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
DiNUC2Binary_RNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin' (String binary): each di-ribonucleotide is represented by a string containing 4 characters(0-1). For example, AA = "0000" AC="0001" ... TT="1111" 'logicBin' (logical value): Each di-ribonucleotide is represented by a vector containing 4 logical entries. For example, AA = c(F,F,F,F) AC=c(F,F,F,T) ... TT=c(T,T,T,T) 'numBin' (numeric bin): Each di-ribonucleotide is represented by a numeric (i.e., integer) vector containing 4 numeric entries. For example, AA = c(0,0,0,0) AC = c(0,0,0,1) ... TT = c(1,1,1,1) |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is (length of the sequences-1). Otherwise, it is equal to (length of the sequences-1)*4. If outFormat is 'txt', all binary values will be written to a 'txt' file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-DiNUC2Binary_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-DiNUC2Binary_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
This function replaces dinucleotides in a sequence with their physicochemical properties in the dinucleotide index file.
DiNUCindex_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
DiNUCindex_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
DiNUCindex_DNA function works based on physicochemical properties. Users, select the properties by their ids or indexes in DI_DNA index file. The default value of this parameter is a vector with ("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist") entries. |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
There are 148 physicochemical indexes in the dinucleotide database.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-1)*(number of selected di-nucleotide indexes) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-DiNUCindex_DNA(seqs = fileLNC,outFormat="mat")
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-DiNUCindex_DNA(seqs = fileLNC,outFormat="mat")
This function replaces di-ribonucleotides in a sequence with their physicochemical properties in the di-ribonucleotide index file.
DiNUCindex_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
DiNUCindex_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
selectedIdx |
DiNucIndex function works based on physicochemical properties. Users, select the properties by their ids or indexes in DI_RNA file. The default value of this parameter is a vector with ("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)","Twist (RNA)") entries. |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
There are 22 physicochemical indexes in the di-ribonucleotide database.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-1)*(number of selected di-ribonucleotide indexes) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-DiNUCindex_RNA(seqs = fileLNC,outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-DiNUCindex_RNA(seqs = fileLNC,outFormat="mat")
This function extracts the ordered and disordered amino acids in protein or peptide sequences. The input to the function is provided by VSL2 software. Also, the function converts order amino acids to '10' and disorder amino acids to '01'.
DisorderB( dirPath, binaryType = "numBin", outFormat = "mat", outputFileDist = "" )
DisorderB( dirPath, binaryType = "numBin", outFormat = "mat", outputFileDist = "" )
dirPath |
Path of the directory which contains all output files of VSL2. Each file belongs to a sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin' (String binary): each amino acid is represented by a string containing 2 characters(0-1). order = "10" disorder="01". 'logicBin' (logical value): Each amino acid is represented by a vector containing 2 logical entries. order = c(TRUE,FALSE) disorder=c(FALSE,TRUE). 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 2 numeric entries. order = c(1,0) disorder=c(0,1). |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*2. If outFormat is 'txt', all binary values will be written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") ad1<-paste0(dir,"/disorderB.txt") DisorderB(PredDisdir,binaryType="numBin",outFormat="txt",outputFileDist=ad1) unlink("dir", recursive = TRUE)
dir = tempdir() PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") ad1<-paste0(dir,"/disorderB.txt") DisorderB(PredDisdir,binaryType="numBin",outFormat="txt",outputFileDist=ad1) unlink("dir", recursive = TRUE)
This function extracts ordered and disordered amino acids in protein or peptide sequences. The input to the function is provided by VSL2 software. Also, the function returns number of order and disorder amino acids in the sequence.
DisorderC(dirPath)
DisorderC(dirPath)
dirPath |
Path of the directory which contains all output files of VSL2. Each file belongs to a sequence. |
The output is a feature matrix with 2 columns. The number of rows is equal to the number of sequences.
dir = tempdir() PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") mat<-DisorderC(PredDisdir)
dir = tempdir() PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") mat<-DisorderC(PredDisdir)
This function extracts ordered and disordered amino acids in protein or peptide sequences. The input to the function is provided by VSL2 software. The function represent order amino acids by 'O' and disorder amino acids by 'D'.
DisorderS(dirPath, outFormat = "mat", outputFileDist = "")
DisorderS(dirPath, outFormat = "mat", outputFileDist = "")
dirPath |
Path of the directory which contains all output files of VSL2. Each file belongs to a sequence. |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
The output depends on the outFormat which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same lengths such that the number of columns is equal to the length of the sequences and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") ad1<-paste0(dir,"/disorderS.txt") DisorderS(PredDisdir, outFormat="txt",outputFileDist=ad1) unlink("dir", recursive = TRUE)
dir = tempdir() PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") ad1<-paste0(dir,"/disorderS.txt") DisorderS(PredDisdir, outFormat="txt",outputFileDist=ad1) unlink("dir", recursive = TRUE)
In this function, first amino acids are grouped into a category which is one of 'cp13', 'cp14', 'cp19', 'cp20'. Users choose one of these terms to categorize amino acids. Then DistancePair function computes frequencies of all grouped residues and also all grouped-paired residues with [0,rng] distance. 'rng' is a parameter which already was set by the user.
DistancePair(seqs, rng = 3, normalized = TRUE, Grp = "cp14", label = c())
DistancePair(seqs, rng = 3, normalized = TRUE, Grp = "cp14", label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
rng |
This parameter is a number. It shows maximum number of spaces between amino acid pairs. For each k in the rng vector, a new vector (whose size is (number of categorizes)^2) is created which contains the frequency of pairs with k gaps. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
Grp |
for this parameter users can choose between these items: 'cp13', 'cp14', 'cp19', or 'cp20'. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. Row length is equal to the number of sequences and the number of columns is (number of categorizes)+((number of categorizes)^2)*(rng+1).
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-DistancePair(seqs=filePrs,rng=2,Grp="cp14")
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-DistancePair(seqs=filePrs,rng=2,Grp="cp14")
This function replaces dinucleotides in a sequence with their physicochemical properties which is multiplied by normalized frequency of that di-nucleotide.
DPCP_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
DPCP_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
DPCP_DNA function works based on physicochemical properties. Users, select the properties by their ids or indexes in DI_DNA index file. The default value of this parameter is a vector with ("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist") entries. |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
There are 148 physicochemical indexes in the dinucleotide database.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-1)*(number of selected di-nucleotide indexes) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-DPCP_DNA(seqs = fileLNC,outFormat="mat")
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-DPCP_DNA(seqs = fileLNC,outFormat="mat")
This function replaces di-ribonucleotides in a sequence with their physicochemical properties which is multiplied by normalized frequency of that di-ribonucleotide.
DPCP_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
DPCP_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
selectedIdx |
DiNucIndex function works based on physicochemical properties. Users, select the properties by their ids or indexes in DI_RNA file. The default value of this parameter is a vector with ("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)","Twist (RNA)") entries. |
threshold |
is a number between (0 , 1]. In selectedAAidx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
There are 22 physicochemical indexes in the di-ribonucleotide database.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-1)*(number of selected di-ribonucleotide indexes) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-DPCP_RNA(seqs = fileLNC,outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-DPCP_RNA(seqs = fileLNC,outFormat="mat")
This function slides a window over the input sequence(s). Also, it computes the composition of amino acids that appears within the limits of the window.
EAAComposition( seqs, winSize = 50, overLap = TRUE, label = c(), outFormat = "mat", outputFileDist = "" )
EAAComposition( seqs, winSize = 50, overLap = TRUE, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
winSize |
is a number which shows the size of the window. |
overLap |
This parameter shows how the window moves over the sequence. If overlap is set to FALSE, the window slides over the sequence in such a way that every time the window moves, it covers a unique portion of the sequence. Otherwise, portions of the sequence which appear within the window limits have "winSize-1" amino acids in common. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
Column names in the output matrix are Wi(aa), where aa shows an amino acid type ("A", "C", "D",..., "Y") and i indicates the number of times that the window has moved over the sequence(s).
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (20 * number of partitions displayed by the window) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
When overlap is FALSE, the last partition represented by the window may have a different length with other parts.
Chen, Zhen, et al. "iFeature: a python package and web server for features extraction and selection from protein and peptide sequences." Bioinformatics 34.14 (2018): 2499-2502.
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-EAAComposition(seqs = ptmSeqsVect,winSize=50, overLap=FALSE,outFormat='mat') ad<-paste0(dir,"/EaaCompos.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") EAAComposition(seqs = filePrs,winSize=50, overLap=FALSE,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-EAAComposition(seqs = ptmSeqsVect,winSize=50, overLap=FALSE,outFormat='mat') ad<-paste0(dir,"/EaaCompos.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") EAAComposition(seqs = filePrs,winSize=50, overLap=FALSE,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
This function calculates the effective number of codon for each sequence.
EffectiveNumberCodon(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
EffectiveNumberCodon(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature vector. The length of the vector is equal to the number of sequences. Each entry in the vector contains the effective number of codon.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-EffectiveNumberCodon(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-EffectiveNumberCodon(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
In this function, amino acids are first grouped into user-defined categories. Then, enhanced grouped amino acid composition is computed. For details about the enhanced feature, please refer to function EAAComposition. Please note that this function differs from function EAAComposition which works on individual amino acids.
EGAAComposition( seqs, winSize = 50, overLap = TRUE, Grp = "locFus", label = c(), outFormat = "mat", outputFileDist = "" )
EGAAComposition( seqs, winSize = 50, overLap = TRUE, Grp = "locFus", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
winSize |
shows the size of sliding window. It is a numeric value. |
overLap |
This parameter shows how the window moves on the sequence. If the overlap is set to TRUE, the next window would have distance 1 with the previous window. Otherwise, the next window will start from the next amino acid after the previous window. There is no overlap between the next and previous windows. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is ((number of categorizes) * (number of windows)) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat1<-EGAAComposition(seqs = ptmSeqsVect,winSize=20,overLap=FALSE,Grp="locFus") mat2<-EGAAComposition(seqs = ptmSeqsVect,winSize=30,overLap=FALSE,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")),outFormat="mat") ad<-paste0(dir,"/EGrpaaCompos.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") EGAAComposition(seqs = filePrs,winSize=20,Grp="cTriad",outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat1<-EGAAComposition(seqs = ptmSeqsVect,winSize=20,overLap=FALSE,Grp="locFus") mat2<-EGAAComposition(seqs = ptmSeqsVect,winSize=30,overLap=FALSE,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")),outFormat="mat") ad<-paste0(dir,"/EGrpaaCompos.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") EGAAComposition(seqs = filePrs,winSize=20,Grp="cTriad",outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
This function replaces each nucleotide in the input sequence with its electron-ion interaction value. The resulting sequence is represented by a feature vector whose length is equal to the length of the sequence. Please check the references for more information.
EIIP(seqs, outFormat = "mat", outputFileDist = "", label = c())
EIIP(seqs, outFormat = "mat", outputFileDist = "", label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is equal to the length of the sequences and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Chen, Zhen, et al. "iLearn: an integrated platform and meta-learner for feature engineering, machine-learning analysis and modeling of DNA, RNA and protein sequence data." Briefings in bioinformatics 21.3 (2020): 1047-1057.
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-EIIP(seqs = LNC50Nuc,outFormat="mat")
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-EIIP(seqs = LNC50Nuc,outFormat="mat")
This function slides a window over the input sequence(s). Also, it computes the composition of nucleotides that appears within the limits of the window.
ENUComposition_DNA( seqs, winSize = 50, overLap = TRUE, label = c(), outFormat = "mat", outputFileDist = "" )
ENUComposition_DNA( seqs, winSize = 50, overLap = TRUE, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
winSize |
is a number which shows the size of the window. |
overLap |
This parameter shows how the window moves on the sequence. If the overlap is set to TRUE, the next window would have distance 1 with the previous window. Otherwise, the next window will start from the next nucleotide after the previous window. There is no overlap between the next and previous windows. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (4 * number of partitions displayed by the window) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-ENUComposition_DNA(seqs = LNC50Nuc, winSize=20,outFormat="mat") ad<-paste0(dir,"/ENUCcompos.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") ENUComposition_DNA(seqs = fileLNC,outFormat="txt",winSize=20 ,outputFileDist=ad,overLap=FALSE) unlink("dir", recursive = TRUE)
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-ENUComposition_DNA(seqs = LNC50Nuc, winSize=20,outFormat="mat") ad<-paste0(dir,"/ENUCcompos.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") ENUComposition_DNA(seqs = fileLNC,outFormat="txt",winSize=20 ,outputFileDist=ad,overLap=FALSE) unlink("dir", recursive = TRUE)
This function slides a window over the input sequence(s). Also, it computes the composition of ribonucleotides that appears within the limits of the window.
ENUComposition_RNA( seqs, winSize = 50, overLap = TRUE, label = c(), outFormat = "mat", outputFileDist = "" )
ENUComposition_RNA( seqs, winSize = 50, overLap = TRUE, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
winSize |
is a number which shows the size of the window. |
overLap |
This parameter shows how the window moves on the sequence. If the overlap is set to TRUE, the next window would have distance 1 with the previous window. Otherwise, the next window will start from the next ribonucleotide after the previous window. There is no overlap between the next and previous windows. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (4 * number of partitions displayed by the window) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-ENUComposition_RNA(seqs = fileLNC, winSize=20,outFormat="mat") ad<-paste0(dir,"/ENUCcompos.txt") ENUComposition_RNA(seqs = fileLNC,outFormat="txt",winSize=20 ,outputFileDist=ad,overLap=FALSE) unlink("dir", recursive = TRUE)
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-ENUComposition_RNA(seqs = fileLNC, winSize=20,outFormat="mat") ad<-paste0(dir,"/ENUCcompos.txt") ENUComposition_RNA(seqs = fileLNC,outFormat="txt",winSize=20 ,outputFileDist=ad,overLap=FALSE) unlink("dir", recursive = TRUE)
This function is introduced by this package for the first time. It computes the expected value for each k-mer in a sequence. ExpectedValue(k-mer) = freq(k-mer) / ( freq(nucleotide1) * freq(nucleotide2) * ... * freq(nucleotidek) )
ExpectedValKmerNUC_DNA( seqs, k = 4, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
ExpectedValKmerNUC_DNA( seqs, k = 4, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
k |
is an integer value. The default is four. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (4^k).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-ExpectedValKmerNUC_DNA(seqs=fileLNC,k=4,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-ExpectedValKmerNUC_DNA(seqs=fileLNC,k=4,ORF=TRUE,reverseORF=FALSE)
This function is introduced by this package for the first time. It computes the expected value for each k-mer in a sequence. ExpectedValue(k-mer) = freq(k-mer) / ( freq(ribonucleotide1) * freq(ribonucleotide2) * ... * freq(ribonucleotidek) )
ExpectedValKmerNUC_RNA( seqs, k = 4, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
ExpectedValKmerNUC_RNA( seqs, k = 4, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
k |
is an integer value. The default is four. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (4^k).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-ExpectedValKmerNUC_RNA(seqs=fileLNC,k=4,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-ExpectedValKmerNUC_RNA(seqs=fileLNC,k=4,ORF=TRUE,reverseORF=FALSE)
This function is introduced by this package for the first time. It computes the expected value for each k-mer in a sequence. ExpectedValue(k-mer) = freq(k-mer) / (c_1 * c_2 * ... * c_k), where c_i is the number of codons that encrypt the i'th amino acid in the k-mer.
ExpectedValueAA(seqs, k = 2, normalized = TRUE, label = c())
ExpectedValueAA(seqs, k = 2, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is an integer value. The default is two. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 20^k.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-ExpectedValueAA(seqs=filePrs,k=2,normalized=FALSE)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-ExpectedValueAA(seqs=filePrs,k=2,normalized=FALSE)
This function is introduced by this package for the first time. In this function, amino acids are first grouped into user-defined categories. Later, the expected value of grouped amino acids is computed. Please note that this function differs from Function ExpectedValueAA which works on individual amino acids.
ExpectedValueGAA(seqs, k = 3, Grp = "locFus", normalized = TRUE, label = c())
ExpectedValueGAA(seqs, k = 3, Grp = "locFus", normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is an integer value. The default is three. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
for more information about ExpectedValueGAA, please refer to function ExpectedValueKmer.
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (number of categories)^k.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-ExpectedValueGAA(seqs=filePrs,k=2,Grp="locFus") mat2<-ExpectedValueGAA(seqs=filePrs,k=1,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-ExpectedValueGAA(seqs=filePrs,k=2,Grp="locFus") mat2<-ExpectedValueGAA(seqs=filePrs,k=1,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
This function is introduced by this package for the first time. In this function, amino acids are first grouped into user-defined categories. Later, the expected value of grouped k-mer is computed. Please note that this function differs from Function ExpectedValueKmerAA which works on individual amino acids.
ExpectedValueGKmerAA( seqs, k = 2, Grp = "locFus", normalized = TRUE, label = c() )
ExpectedValueGKmerAA( seqs, k = 2, Grp = "locFus", normalized = TRUE, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is an integer. The default value is two. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (number of categorizes)^k.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-ExpectedValueGKmerAA(seqs=filePrs,k=2,Grp="locFus") mat2<-ExpectedValueGKmerAA(seqs=filePrs,k=1,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-ExpectedValueGKmerAA(seqs=filePrs,k=2,Grp="locFus") mat2<-ExpectedValueGKmerAA(seqs=filePrs,k=1,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
This function computes the expected value of each k-mer by dividing the frequency of the kmer to multiplying frequency of each amino acid of the k-mer in the sequence.
ExpectedValueKmerAA(seqs, k = 2, normalized = TRUE, label = c())
ExpectedValueKmerAA(seqs, k = 2, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is an integer value and it shows the size of kmer in the kmer composition. The default value is 2. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
ExpectedValue(k-mer) = freq(k-mer) / ( freq(aminoacid1) * freq(aminoacid2) * ... * freq(aminoacidk) )
This function returns a feature matrix. The number of rows equals the number of sequences and the number of columns if upto set false, is 20^k.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-ExpectedValueKmerAA(filePrs,k=2,normalized=FALSE)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-ExpectedValueKmerAA(filePrs,k=2,normalized=FALSE)
This function reads a FASTA file. Each sequence starts with '>' in the file. This is a general function which can be applied to all types of sequences (i.e., protein/peptide, dna, and rna).
fa.read(file, legacy.mode = TRUE, seqonly = FALSE, alphabet = "aa")
fa.read(file, legacy.mode = TRUE, seqonly = FALSE, alphabet = "aa")
file |
The address of the FASTA file. |
legacy.mode |
comments all lines which start with ";". |
seqonly |
if it is set to true, the function will return sequences with no description. |
alphabet |
is a vector which contains amino acid, RNA, or DNA alphabets. |
a string vector such that each element is a sequence.
https://cran.r-project.org/web/packages/rDNAse/index.html
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") sequenceVectLNC<-fa.read(file=fileLNC,alphabet="dna") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") sequenceVectPRO<-fa.read(file=filePrs,alphabet="aa")
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") sequenceVectLNC<-fa.read(file=fileLNC,alphabet="dna") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") sequenceVectPRO<-fa.read(file=filePrs,alphabet="aa")
This function calculates the ficket score of each sequence.
fickettScore(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
fickettScore(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature vector. The length of the vector is equal to the number of sequences. Each entry in the vector contains the value of the fickett score.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-fickettScore(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-fickettScore(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This function calculates G-C content of each sequence.
G_Ccontent_DNA( seqs, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
G_Ccontent_DNA( seqs, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature vector. The length of the vector is equal to the number of sequences. Each entry in the vector contains G-C content of a sequence.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-G_Ccontent_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-G_Ccontent_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This function calculates G-C content of each sequence.
G_Ccontent_RNA( seqs, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
G_Ccontent_RNA( seqs, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The function returns a feature vector. The length of the vector is equal to the number of sequences. Each entry in the vector contains G-C content of a sequence.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-G_Ccontent_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-G_Ccontent_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
In this function, amino acids are first grouped into user-defined categories. Later, the composition of the grouped amino acid k part is computed. Please note that this function differs from AAKpartComposition which works on individual amino acids.
GAAKpartComposition( seqs, k = 5, normalized = TRUE, Grp = "locFus", label = c() )
GAAKpartComposition( seqs, k = 5, normalized = TRUE, Grp = "locFus", label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is an integer. Each sequence should be divided to k partition(s). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
a feature matrix with k*(number of categorizes) number of columns. The number of rows is equal to the number of sequences.
Warning: The length of all sequences should be greater than k.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-GAAKpartComposition(seqs=filePrs,k=5,Grp="aromatic") mat2<-GAAKpartComposition(seqs=filePrs,k=3,normalized=FALSE,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-GAAKpartComposition(seqs=filePrs,k=5,Grp="aromatic") mat2<-GAAKpartComposition(seqs=filePrs,k=3,normalized=FALSE,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
This function is introduced by this package for the first time. In this function, amino acids are first grouped into user-defined categories. Later, DDE is applied to grouped amino acids. Please note that this function differs from DDE which works on individual amino acids.
GrpDDE(seqs, Grp = "locFus", label = c())
GrpDDE(seqs, Grp = "locFus", label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A feature matrix with (number of categorizes)^2 number of columns. The number of rows is equal to the number of sequences.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-GrpDDE(seqs=filePrs,Grp="aromatic") mat2<-GrpDDE(seqs=filePrs,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-GrpDDE(seqs=filePrs,Grp="aromatic") mat2<-GrpDDE(seqs=filePrs,Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
This function calculates the frequency of all k-mers in the sequence(s).
kAAComposition(seqs, rng = 3, upto = FALSE, normalized = TRUE, label = c())
kAAComposition(seqs, rng = 3, upto = FALSE, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
rng |
This parameter can be a number or a vector. Each entry of the vector holds the value of k in the k-mer composition. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from 1 to rng. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns depends on rng vector. For each value k in the vector, (20)^k columns are created in the matrix.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-kAAComposition(seqs=filePrs,rng=3,upto=TRUE) mat2<-kAAComposition(seqs=filePrs,rng=c(1,3),upto=TRUE)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-kAAComposition(seqs=filePrs,rng=3,upto=TRUE) mat2<-kAAComposition(seqs=filePrs,rng=c(1,3),upto=TRUE)
In this function, amino acids are first grouped into user-defined categories. Later, the composition of the k grouped amino acids is computed. Please note that this function differs from kAAComposition which works on individual amino acids.
kGAAComposition( seqs, rng = 3, upto = FALSE, normalized = TRUE, Grp = "locFus", label = c() )
kGAAComposition( seqs, rng = 3, upto = FALSE, normalized = TRUE, Grp = "locFus", label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
rng |
This parameter can be a number or a vector. Each entry of the vector holds the value of k in the k-mer composition. For each k in the rng vector, a new vector (whose size is 20^k) is created which contains the frequency of k-mers. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from 1 to rng. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
for more details, please refer to kAAComposition
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is ((number of categorizes)^k)*(length of rng vector).
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-CkSGAApair(seqs=filePrs,rng=2,upto=TRUE,Grp="aromatic") mat2<-CkSGAApair(seqs=filePrs,rng=c(1,3,5),Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-CkSGAApair(seqs=filePrs,rng=2,upto=TRUE,Grp="aromatic") mat2<-CkSGAApair(seqs=filePrs,rng=c(1,3,5),Grp= list(Grp1=c("G","A","V","L","M","I","F","Y","W"),Grp2=c("K","R","H","D","E") ,Grp3=c("S","T","C","P","N","Q")))
This function is like KNNPeptide with the difference that similarity score is computed by Needleman-Wunsch algorithm.
KNN_DNA(seqs, trainSeq, percent = 30, labeltr = c(), label = c())
KNN_DNA(seqs, trainSeq, percent = 30, labeltr = c(), label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
trainSeq |
is a fasta file with nucleotide sequences. Each sequence starts with a '>' character. Also it could be a string vector such that each element is a nucleotide sequence. Eaxh sequence in the training set is associated with a label. The label is found in the parameret labeltr. |
percent |
determines the threshold which is used to identify sequences (in the training set) which are similar to the input sequence. |
labeltr |
This parameter is a vector whose length is equivalent to the number of sequences in the training set. It shows class of each sequence in the trainig set. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix such that number of columns is number of classes multiplied by percent and number of rows is equal to the number of the sequences.
Chen, Zhen, et al. "iFeature: a python package and web server for features extraction and selection from protein and peptide sequences." Bioinformatics 34.14 (2018): 2499-2502.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testData51.txt"),alphabet="dna") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/posData51.txt"),alphabet="dna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/negData51.txt"),alphabet="dna") trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) KNN_DNA(seqs=seqs,trainSeq=trainSeq,percent=5,labeltr=labeltr)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testData51.txt"),alphabet="dna") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/posData51.txt"),alphabet="dna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/negData51.txt"),alphabet="dna") trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) KNN_DNA(seqs=seqs,trainSeq=trainSeq,percent=5,labeltr=labeltr)
This function is like KNNPeptide with the difference that similarity score is computed by Needleman-Wunsch algorithm.
KNN_RNA(seqs, trainSeq, percent = 30, labeltr = c(), label = c())
KNN_RNA(seqs, trainSeq, percent = 30, labeltr = c(), label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
trainSeq |
is a fasta file with ribonucleotide sequences. Each sequence starts with a '>' character. Also it could be a string vector such that each element is a ribonucleotide sequence. Eaxh sequence in the training set is associated with a label. The label is found in the parameret labeltr. |
percent |
determines the threshold which is used to identify sequences (in the training set) which are similar to the input sequence. |
labeltr |
This parameter is a vector whose length is equivalent to the number of sequences in the training set. It shows class of each sequence in the trainig set. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix such that number of columns is number of classes multiplied by percent and number of rows is equal to the number of the sequences.
Wei,L., Su,R., Luan,S., Liao,Z., Manavalan,B., Zou,Q. and Shi,X. Iterative feature representations improve N4-methylcytosine site prediction. Bioinformatics, (2019).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/pos2RNA51.txt"),alphabet="rna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/neg2RNA51.txt"),alphabet="rna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testSeq2RNA51.txt"),alphabet="rna") trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) KNN_RNA(seqs=seqs,trainSeq=trainSeq,percent=10,labeltr=labeltr)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/pos2RNA51.txt"),alphabet="rna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/neg2RNA51.txt"),alphabet="rna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testSeq2RNA51.txt"),alphabet="rna") trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) KNN_RNA(seqs=seqs,trainSeq=trainSeq,percent=10,labeltr=labeltr)
This function needs an extra training data set and a label. We compute the similarity score of each input sequence with all sequences in the training data set. We use the BLOSUM62 matrix to compute the similarity score. The label shows the class of each sequence in the training data set. KNNPeptide finds the label of 1 It reports the frequency of each class for each k
KNNPeptide(seqs, trainSeq, percent = 30, label = c(), labeltr = c())
KNNPeptide(seqs, trainSeq, percent = 30, label = c(), labeltr = c())
seqs |
is a fasta file with amino acids sequences. Each sequence starts with a '>' character or it is a string vector such that each element is a peptide or protein sequence. |
trainSeq |
is a fasta file with amino acids sequences. Each sequence starts with a '>' character. Also it could be a string vector such that each element is a peptide sequence. Eaxh sequence in the training set is associated with a label. The label is found in the parameret labeltr. |
percent |
determines the threshold which is used to identify sequences (in the training set) which are similar to the input sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
labeltr |
This parameter is a vector whose length is equivalent to the number of sequences in the training set. It shows class of each sequence in the trainig set. |
This function returns a feature matrix such that number of columns is number of classes multiplied by percent and number of rows is equal to the number of the sequences.
This function is usable for amino acid sequences with the same length in both training data set and the set of sequences.
Chen, Zhen, et al. "iFeature: a python package and web server for features extraction and selection from protein and peptide sequences." Bioinformatics 34.14 (2018): 2499-2502.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) posSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/poSeqPTM101.csv"))[,2]) negSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/negSeqPTM101.csv"))[,2]) posSeqs<-posSeqs[1:10] negSeqs<-negSeqs[1:10] trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) KNNPeptide(seqs=ptmSeqsVect,trainSeq=trainSeq,percent=10,labeltr=labeltr)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) posSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/poSeqPTM101.csv"))[,2]) negSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/negSeqPTM101.csv"))[,2]) posSeqs<-posSeqs[1:10] negSeqs<-negSeqs[1:10] trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) KNNPeptide(seqs=ptmSeqsVect,trainSeq=trainSeq,percent=10,labeltr=labeltr)
This function is like KNNPeptide with the difference that similarity score is computed by Needleman-Wunsch algorithm.
KNNProtein(seqs, trainSeq, percent = 30, labeltr = c(), label = c())
KNNProtein(seqs, trainSeq, percent = 30, labeltr = c(), label = c())
seqs |
is a fasta file with amino acids sequences. Each sequence starts with a '>' character. Also it could be a string vector such that each element is a protein sequence. |
trainSeq |
is a fasta file with amino acids sequences. Each sequence starts with a '>' character. Also it could be a string vector such that each element is a protein sequence. Eaxh sequence in the training set is associated with a label. The label is found in the parameret labeltr. |
percent |
determines the threshold which is used to identify sequences (in the training set) which are similar to the input sequence. |
labeltr |
This parameter is a vector whose length is equivalent to the number of sequences in the training set. It shows class of each sequence in the trainig set. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix such that number of columns is number of classes multiplied by percent and number of rows is equal to the number of the sequences.
Chen, Zhen, et al. "iFeature: a python package and web server for features extraction and selection from protein and peptide sequences." Bioinformatics 34.14 (2018): 2499-2502.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) ptmSeqsVect<-ptmSeqsVect[1:2] ptmSeqsVect<-sapply(ptmSeqsVect,function(seq){substr(seq,1,31)}) posSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/poSeqPTM101.csv"))[,2]) negSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/negSeqPTM101.csv"))[,2]) posSeqs<-posSeqs[1:3] negSeqs<-negSeqs[1:3] posSeqs<-sapply(posSeqs,function(seq){substr(seq,1,31)}) negSeqs<-sapply(negSeqs,function(seq){substr(seq,1,31)}) trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) mat<-KNNProtein(seqs=ptmSeqsVect,trainSeq=trainSeq,percent=5,labeltr=labeltr)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) ptmSeqsVect<-ptmSeqsVect[1:2] ptmSeqsVect<-sapply(ptmSeqsVect,function(seq){substr(seq,1,31)}) posSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/poSeqPTM101.csv"))[,2]) negSeqs<-as.vector(read.csv(paste0(ptmSeqsADR,"/negSeqPTM101.csv"))[,2]) posSeqs<-posSeqs[1:3] negSeqs<-negSeqs[1:3] posSeqs<-sapply(posSeqs,function(seq){substr(seq,1,31)}) negSeqs<-sapply(negSeqs,function(seq){substr(seq,1,31)}) trainSeq<-c(posSeqs,negSeqs) labelPos<-rep(1,length(posSeqs)) labelNeg<-rep(0,length(negSeqs)) labeltr<-c(labelPos,labelNeg) mat<-KNNProtein(seqs=ptmSeqsVect,trainSeq=trainSeq,percent=5,labeltr=labeltr)
This function calculates the frequency of all k-mers in the sequence.
kNUComposition_DNA( seqs, rng = 3, reverse = FALSE, upto = FALSE, normalized = TRUE, ORF = FALSE, reverseORF = TRUE, label = c() )
kNUComposition_DNA( seqs, rng = 3, reverse = FALSE, upto = FALSE, normalized = TRUE, ORF = FALSE, reverseORF = TRUE, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
rng |
This parameter can be a number or a vector. Each entry of the vector holds the value of k in the k-mer composition. For each k in the rng vector, a new vector (whose size is 4^k) is created which contains the frequency of kmers. |
reverse |
It is a logical parameter which assumes the reverse complement of the sequence. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from 1 to rng. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns depends on the rng vector. For each value k in the vector, (4)^k columns are created in the matrix.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-kNUComposition_DNA(seqs=fileLNC,rng=c(1,3))
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-kNUComposition_DNA(seqs=fileLNC,rng=c(1,3))
This function calculates the frequency of all k-mers in the sequence.
kNUComposition_RNA( seqs, rng = 3, reverse = FALSE, upto = FALSE, normalized = TRUE, ORF = FALSE, reverseORF = TRUE, label = c() )
kNUComposition_RNA( seqs, rng = 3, reverse = FALSE, upto = FALSE, normalized = TRUE, ORF = FALSE, reverseORF = TRUE, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
rng |
This parameter can be a number or a vector. Each entry of the vector holds the value of k in the k-mer composition. For each k in the rng vector, a new vector (whose size is 4^k) is created which contains the frequency of kmers. |
reverse |
It is a logical parameter which assumes the reverse complement of the sequence. |
upto |
It is a logical parameter. The default value is FALSE. If rng is a number and upto is set to TRUE, rng is converted to a vector with values from 1 to rng. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns depends on the rng vector. For each value k in the vector, (4)^k columns are created in the matrix.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-kNUComposition_RNA(seqs=fileLNC,rng=c(1,3))
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-kNUComposition_RNA(seqs=fileLNC,rng=c(1,3))
For each sequence, this function creates a feature vector denoted as (f1,f2, f3, …, fN), where fi = freq(i'th k-mer of the sequence) / i. It should be applied to sequences with the same length.
LocalPoSpKAAF(seqs, k = 2, label = c(), outFormat = "mat", outputFileDist = "")
LocalPoSpKAAF(seqs, k = 2, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
is a numeric value which holds the value of k in the k-mers. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-k+1) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-LocalPoSpKAAF(seqs = ptmSeqsVect, k=2,outFormat="mat") ad<-paste0(dir,"/LocalPoSpKaaF.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") LocalPoSpKAAF(seqs = filePrs, k=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-LocalPoSpKAAF(seqs = ptmSeqsVect, k=2,outFormat="mat") ad<-paste0(dir,"/LocalPoSpKaaF.txt") filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") LocalPoSpKAAF(seqs = filePrs, k=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
For each sequence, this function creates a feature vector denoted as (f1,f2, f3, …, fN), where fi = freq(i'th k-mer of the sequence) / i. It should be applied to sequences with the same length.
LocalPoSpKNUCF_DNA( seqs, k = 2, label = c(), outFormat = "mat", outputFileDist = "" )
LocalPoSpKNUCF_DNA( seqs, k = 2, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
k |
is a numeric value which holds the value of k in the k-mers. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-k+1) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-LocalPoSpKNUCF_DNA(seqs = LNC50Nuc, k=2,outFormat="mat") ad<-paste0(dir,"/LocalPoSpKnucF.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") LocalPoSpKNUCF_DNA(seqs = fileLNC,k=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-LocalPoSpKNUCF_DNA(seqs = LNC50Nuc, k=2,outFormat="mat") ad<-paste0(dir,"/LocalPoSpKnucF.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") LocalPoSpKNUCF_DNA(seqs = fileLNC,k=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
For each sequence, this function creates a feature vector denoted as (f1,f2, f3, …, fN), where fi = freq(i'th k-mer of the sequence) / i. It should be applied to sequences with the same length.
LocalPoSpKNUCF_RNA( seqs, k = 2, label = c(), outFormat = "mat", outputFileDist = "" )
LocalPoSpKNUCF_RNA( seqs, k = 2, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
k |
is a numeric value which holds the value of k in the k-mers. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-k+1) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-LocalPoSpKNUCF_RNA(seqs = fileLNC, k=2,outFormat="mat") ad<-paste0(dir,"/LocalPoSpKnucF.txt") fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") LocalPoSpKNUCF_RNA(seqs = fileLNC,k=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-LocalPoSpKNUCF_RNA(seqs = fileLNC, k=2,outFormat="mat") ad<-paste0(dir,"/LocalPoSpKnucF.txt") fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") LocalPoSpKNUCF_RNA(seqs = fileLNC,k=1,outFormat="txt" ,outputFileDist=ad) unlink("dir", recursive = TRUE)
This function gets a sequence as the input. If reverse is true, the function extracts the max Open Reading Frame in the sequence and its reverse complement (hint: Six frames). Otherwise, only the sequence is searched (hint: Three frames).
maxORF(seqs, reverse = TRUE, label = c())
maxORF(seqs, reverse = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
reverse |
It is a logical parameter which assumes the reverse complement of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A vector containing a subsequence for each given sequences. The subsequence is the maximum ORF of the sequence.
If a sequence does not contain ORF, the function deletes the sequence.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") ORF<-maxORF(seqs=fileLNC,reverse=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") ORF<-maxORF(seqs=fileLNC,reverse=FALSE)
This function gets a sequence as the input. If reverse is true, the function extracts the max Open Reading Frame in the sequence and its reverse complement (hint: Six frames). Otherwise, only the sequence is searched (hint: Three frames).
maxORF_RNA(seqs, reverse = TRUE, label = c())
maxORF_RNA(seqs, reverse = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
reverse |
It is a logical parameter which assumes the reverse complement of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A vector containing a subsequence for each given sequences. The subsequence is the maximum ORF of the sequence.
If a sequence does not contain ORF, the function deletes the sequence.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") ORF<-maxORF_RNA(seqs=fileLNC,reverse=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") ORF<-maxORF_RNA(seqs=fileLNC,reverse=FALSE)
This function returns the length of the maximum Open Reading Frame for each sequence. If reverse is FALSE, ORF region will be searched in a sequence. Otherwise, it will be searched both in the sequence and its reverse complement.
maxORFlength_DNA(seqs, reverse = TRUE, normalized = FALSE, label = c())
maxORFlength_DNA(seqs, reverse = TRUE, normalized = FALSE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
reverse |
It is a logical parameter which assumes the reverse complement of the sequence. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A vector containing the lengths of maximum ORFs for each sequence.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-maxORFlength_DNA(seqs=fileLNC,reverse=TRUE,normalized=TRUE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") vect<-maxORFlength_DNA(seqs=fileLNC,reverse=TRUE,normalized=TRUE)
This function returns the length of the maximum Open Reading Frame for each sequence. If reverse is FALSE, ORF region will be searched in a sequence. Otherwise, it will be searched both in the sequence and its reverse complement.
maxORFlength_RNA(seqs, reverse = TRUE, normalized = FALSE, label = c())
maxORFlength_RNA(seqs, reverse = TRUE, normalized = FALSE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
reverse |
It is a logical parameter which assumes the reverse complement of the sequence. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A vector containing the lengths of maximum ORFs for each sequence.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-maxORFlength_RNA(seqs=fileLNC,reverse=TRUE,normalized=TRUE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") vect<-maxORFlength_RNA(seqs=fileLNC,reverse=TRUE,normalized=TRUE)
This function also calculates the frequencies of all k-mers in the sequence but alows maximum m mismatch. m<k.
Mismatch_DNA(seqs, k = 3, m = 2, label = c())
Mismatch_DNA(seqs, k = 3, m = 2, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
k |
This parameter can be a number which shows kmer. |
m |
This parametr shows muximum number of mismatches. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns depends on the rng vector. For each value k in the vector, (4)^k columns are created in the matrix.
Liu, B., Gao, X. and Zhang, H. BioSeq-Analysis2.0: an updated platform for analyzing DNA, RNA and protein sequences at sequence level and residue level based on machine learning approaches. Nucleic Acids Res (2019).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Mismatch_DNA(seqs=fileLNC)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Mismatch_DNA(seqs=fileLNC)
This function also calculates the frequencies of all k-mers in the sequence but alows maximum m mismatch. m<k.
Mismatch_RNA(seqs, k = 3, m = 2, label = c())
Mismatch_RNA(seqs, k = 3, m = 2, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
k |
This parameter can be a number which shows kmer. |
m |
This parametr shows muximum number of mismatches. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns depends on the rng vector. For each value k in the vector, (4)^k columns are created in the matrix.
Liu, B., Gao, X. and Zhang, H. BioSeq-Analysis2.0: an updated platform for analyzing DNA, RNA and protein sequences at sequence level and residue level based on machine learning approaches. Nucleic Acids Res (2019).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Mismatch_RNA(seqs=fileLNC)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Mismatch_RNA(seqs=fileLNC)
MMI computes mutual information based on 2-mers T2 = AA, AC, AG, AT, CC, CG, CT, GG, GT, TT and 3-mers T3 = AAA, AAC, AAG, AAT, ACC, ACG, ACT, AGG, AGT, ATT, CCC, CCG, CCT, CGG, CGT, CTT, GGG, GGT, GTT and TTT for more information please check the reference part.
MMI_DNA(seqs, label = c())
MMI_DNA(seqs, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
It is a feature matrix. The number of columns is 30 and the number of rows is equal to the number of sequences.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song. iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research (2021).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-MMI_DNA(seqs=fileLNC)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-MMI_DNA(seqs=fileLNC)
MMI computes mutual information based on 2-mers T2 = AA, AC, AG, AU, CC, CG, CU, GG, GU, U and 3-mers T3 = AAA, AAC, AAG, AAU, ACC, ACG, ACU, AGG, AGU, AUU, CCC, CCG, CCU, CGG, CGU, CUU, GGG, GGU, GUU and UUU for more information please check the reference part.
MMI_RNA(seqs, label = c())
MMI_RNA(seqs, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
It is a feature matrix. The number of columns is 30 and the number of rows is equal to the number of sequences.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song. iLearnPlus: a comprehensive and automated machine-learning platform for ribonucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research (2021).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-MMI_RNA(seqs=fileLNC)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-MMI_RNA(seqs=fileLNC)
This function creates all possible k-combinations of the given alphabets.
nameKmer(k = 3, type = "aa", num = 0)
nameKmer(k = 3, type = "aa", num = 0)
k |
is a numeric value. |
type |
can be one of "aa", "rna", "dna", or "num". |
num |
When type is set to "num", it shows the numeric alphabet( 1,..,,num). |
a string vector of length (20^k for 'aa' type), (4^k for 'dna' type), (4^k for 'rna' type), and (num^k for 'num' type).
all_kmersAA<-nameKmer(k=2,type="aa") all_kmersDNA<-nameKmer(k=3,type="dna") all_kmersNUM<-nameKmer(k=3,type="num",num=2)
all_kmersAA<-nameKmer(k=2,type="aa") all_kmersDNA<-nameKmer(k=3,type="dna") all_kmersNUM<-nameKmer(k=3,type="num",num=2)
This function replaces nucleotides with a three-length vector. The vector represent the nucleotides such that 'A' will be replaced with c(1, 1, 1), 'C' with c(0, 1, 0),'G' with c(1, 0, 0), and 'T' with c(0, 0, 1).
NCP_DNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
NCP_DNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each nucleotide is represented by a string containing 4 characters(0-1). A = "0001" , C = "0010" , G = "0100" , T = "1000" 'logicBin'(logical value): Each nucleotide is represented by a vector containing 4 logical entries. A = c(F,F,F,T) , ... , T = c(T,F,F,F) 'numBin' (numeric bin): Each nucleotide is represented by a numeric (i.e., integer) vector containing 4 numerals. A = c(0,0,0,1) , ... , T = c(1,0,0,0) |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Chen, Zhen, et al. "iLearn: an integrated platform and meta-learner for feature engineering, machine-learning analysis and modeling of DNA, RNA and protein sequence data." Briefings in bioinformatics 21.3 (2020): 1047-1057.
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-NCP_DNA(seqs = LNC50Nuc,binaryType="strBin",outFormat="mat") ad<-paste0(dir,"/NCP.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") NCP_DNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-NCP_DNA(seqs = LNC50Nuc,binaryType="strBin",outFormat="mat") ad<-paste0(dir,"/NCP.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") NCP_DNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function replaces ribonucleotides with a three-length vector. The vector represent the ribonucleotides such that 'A' will be replaced with c(1, 1, 1), 'C' with c(0, 1, 0),'G' with c(1, 0, 0), and 'U' with c(0, 0, 1).
NCP_RNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
NCP_RNA( seqs, binaryType = "numBin", outFormat = "mat", outputFileDist = "", label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each ribonucleotide is represented by a string containing 4 characters(0-1). A = "0001" , C = "0010" , G = "0100" , T = "1000" 'logicBin'(logical value): Each ribonucleotide is represented by a vector containing 4 logical entries. A = c(F,F,F,T) , ... , T = c(T,F,F,F) 'numBin' (numeric bin): Each ribonucleotide is represented by a numeric (i.e., integer) vector containing 4 numerals. A = c(0,0,0,1) , ... , T = c(1,0,0,0) |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Chen, Zhen, et al. "iLearn: an integrated platform and meta-learner for feature engineering, machine-learning analysis and modeling of DNA, RNA and protein sequence data." Briefings in bioinformatics 21.3 (2020): 1047-1057.
dir = tempdir() fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-NCP_RNA(seqs = fileLNC,binaryType="strBin",outFormat="mat") ad<-paste0(dir,"/NCP.txt") NCP_RNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-NCP_RNA(seqs = fileLNC,binaryType="strBin",outFormat="mat") ad<-paste0(dir,"/NCP.txt") NCP_RNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function works based on Needleman-Wunsch algorithm which computes similarity score of two sequences.
needleman(seq1, seq2, gap = -1, mismatch = -1, match = 1)
needleman(seq1, seq2, gap = -1, mismatch = -1, match = 1)
seq1 |
(sequence1) is a string. |
seq2 |
(sequence2) is a string. |
gap |
The penalty for gaps in sequence alignment. Usually, it is a negative value. |
mismatch |
The penalty for the mismatch in the sequence alignment. Usually, it is a negative value. |
match |
A score for the match in sequence alignment. Usually, it is a positive value. |
The function returns a number which indicates the similarity between sequence1 and sequence2.
https://gist.github.com/juliuskittler/ed53696ac1e590b413aac2dddf0457f6
simScore<-needleman(seq1="Hello",seq2="Hello",gap=-1,mismatch=-2,match=1)
simScore<-needleman(seq1="Hello",seq2="Hello",gap=-1,mismatch=-2,match=1)
This function returns sequences which contain at least one non-standard alphabet.
nonStandardSeq(file, legacy.mode = TRUE, seqonly = FALSE, alphabet = "aa")
nonStandardSeq(file, legacy.mode = TRUE, seqonly = FALSE, alphabet = "aa")
file |
The address of fasta file which contains all the sequences. |
legacy.mode |
It comments all lines starting with ";" |
seqonly |
If it is set to true, the function returns sequences with no description. |
alphabet |
It is a vector which contains the amino acid, RNA, or DNA alphabets. |
This function returns a string vector. Each element of the vector is a sequence which contains at least one non-standard alphabet.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") nonStandardPrSeq<-nonStandardSeq(file = filePrs,alphabet="aa") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") nonStandardNUCSeq<-nonStandardSeq(file = filePrs, alphabet="dna")
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") nonStandardPrSeq<-nonStandardSeq(file = filePrs,alphabet="aa") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") nonStandardNUCSeq<-nonStandardSeq(file = filePrs, alphabet="dna")
This function transforms a nucleotide to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
NUC2Binary_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
NUC2Binary_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each nucleotide is represented by a string containing 4 characters(0-1). A = "0001" , C = "0010" , G = "0100" , T = "1000" 'logicBin'(logical value): Each nucleotide is represented by a vector containing 4 logical entries. A = c(F,F,F,T) , ... , T = c(T,F,F,F) 'numBin' (numeric bin): Each nucleotide is represented by a numeric (i.e., integer) vector containing 4 numerals. A = c(0,0,0,1) , ... , T = c(1,0,0,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*4. If outFormat is 'txt', all binary values will be written to a 'txt' file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes.
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-NUC2Binary_DNA(seqs = LNC50Nuc,outFormat="mat") ad<-paste0(dir,"/NUC2Binary.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") NUC2Binary_DNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-NUC2Binary_DNA(seqs = LNC50Nuc,outFormat="mat") ad<-paste0(dir,"/NUC2Binary.txt") fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") NUC2Binary_DNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function transforms a ribonucleotide to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
NUC2Binary_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
NUC2Binary_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each ribonucleotide is represented by a string containing 4 characters(0-1). A = "0001" , C = "0010" , G = "0100" , U = "1000" 'logicBin'(logical value): Each ribonucleotide is represented by a vector containing 4 logical entries. A = c(F,F,F,T) , ... , U = c(T,F,F,F) 'numBin' (numeric bin): Each ribonucleotide is represented by a numeric (i.e., integer) vector containing 4 numerals. A = c(0,0,0,1) , ... , U = c(1,0,0,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*4. If outFormat is 'txt', all binary values will be written to a 'txt' file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes.
dir = tempdir() fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-NUC2Binary_RNA(seqs = fileLNC,outFormat="mat") ad<-paste0(dir,"/NUC2Binary.txt") NUC2Binary_RNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-NUC2Binary_RNA(seqs = fileLNC,outFormat="mat") ad<-paste0(dir,"/NUC2Binary.txt") NUC2Binary_RNA(seqs = fileLNC,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
In this function, each sequence is divided into k equal partitions. The length of each part is equal to ceiling(l(lenght of the sequence)/k). The last part can have a different length containing the residual nucleotides. The nucleotide composition is calculated for each part.
NUCKpartComposition_DNA( seqs, k = 5, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
NUCKpartComposition_DNA( seqs, k = 5, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
k |
is an integer value. Each sequence should be divided to k partition(s). |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
a feature matrix with k*4 number of columns. The number of rows is equal to the number of sequences.
Warning: The length of all sequences should be greater than k.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-NUCKpartComposition_DNA(seqs=fileLNC,k=5,ORF=TRUE,reverseORF=FALSE,normalized=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-NUCKpartComposition_DNA(seqs=fileLNC,k=5,ORF=TRUE,reverseORF=FALSE,normalized=FALSE)
In this function, each sequence is divided into k equal partitions. The length of each part is equal to ceiling(l(lenght of the sequence)/k). The last part can have a different length containing the residual ribonucleotides. The ribonucleotide composition is calculated for each part.
NUCKpartComposition_RNA( seqs, k = 5, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
NUCKpartComposition_RNA( seqs, k = 5, ORF = FALSE, reverseORF = TRUE, normalized = TRUE, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
k |
is an integer value. Each sequence should be divided to k partition(s). |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
a feature matrix with k*4 number of columns. The number of rows is equal to the number of sequences.
Warning: The length of all sequences should be greater than k.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-NUCKpartComposition_RNA(seqs=fileLNC,k=5,ORF=TRUE,reverseORF=FALSE,normalized=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-NUCKpartComposition_RNA(seqs=fileLNC,k=5,ORF=TRUE,reverseORF=FALSE,normalized=FALSE)
This group of functions (OPF Group) categorize amino acids in different groups based on the type. This function includes 10 amino acid properties. OPF_10bit substitutes each amino acid with a 10-dimensional vector. Each element of the vector shows if that amino acid locates in a special property category or not. '0' means that amino acid is not located in that property group and '1' means it is located.
OPF_10bit(seqs, label = c(), outFormat = "mat", outputFileDist = "")
OPF_10bit(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. Number of columns for this feature matrix is equal to (length of the sequences)*10 and number of rows is equal to the number of sequences. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Wei,L., Zhou,C., Chen,H., Song,J. and Su,R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_10bit(seqs = ptmSeqsVect,outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_10bit(seqs = ptmSeqsVect,outFormat="mat")
This group of functions (OPF Group) categorize amino acids in different groups based on the type. This function includes 7 amino acid properties. OPF_7bit_T1 substitutes each amino acid with a 7-dimensional vector. Each element of the vector shows if that amino acid locates in a special property category or not. '0' means that amino acid is not located in that property group and '1' means it is located. The only difference between OPF_7bit type1, type2, and type3 is in localization of amino acids in the properties groups.
OPF_7bit_T1(seqs, label = c(), outFormat = "mat", outputFileDist = "")
OPF_7bit_T1(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. Number of columns for this feature matrix is equal to (length of the sequences)*7 and number of rows is equal to the number of sequences. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Wei,L., Zhou,C., Chen,H., Song,J. and Su,R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_7bit_T1(seqs = ptmSeqsVect,outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_7bit_T1(seqs = ptmSeqsVect,outFormat="mat")
This group of functions (OPF Group) categorize amino acids in different groups based on the type. This function includes 7 amino acid properties. OPF_7bit_T2 substitutes each amino acid with a 7-dimensional vector. Each element of the vector shows if that amino acid locates in a special property category or not. '0' means that amino acid is not located in that property group and '1' means it is located. The only difference between OPF_7bit type1, type2, and type3 is in localization of amino acids in the properties groups.
OPF_7bit_T2(seqs, label = c(), outFormat = "mat", outputFileDist = "")
OPF_7bit_T2(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. Number of columns for this feature matrix is equal to (length of the sequences)*7 and number of rows is equal to the number of sequences. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Wei,L., Zhou,C., Chen,H., Song,J. and Su,R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_7bit_T2(seqs = ptmSeqsVect,outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_7bit_T2(seqs = ptmSeqsVect,outFormat="mat")
This group of functions (OPF Group) categorize amino acids in different groups based on the type. This function includes 7 amino acid properties. OPF_7bit_T3 substitutes each amino acid with a 7-dimensional vector. Each element of the vector shows if that amino acid locates in a special property category or not. '0' means that amino acid is not located in that property group and '1' means it is located. The only difference between OPF_7bit type1, type2, and type3 is in localization of amino acids in the properties groups.
OPF_7bit_T3(seqs, label = c(), outFormat = "mat", outputFileDist = "")
OPF_7bit_T3(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. Number of columns for this feature matrix is equal to (length of the sequences)*7 and number of rows is equal to the number of sequences. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Wei,L., Zhou,C., Chen,H., Song,J. and Su,R. ACPred-FL: a sequence-based predictor using effective feature representation to improve the prediction of anti-cancer peptides. Bioinformatics (2018).
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_7bit_T3(seqs = ptmSeqsVect,outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-OPF_7bit_T3(seqs = ptmSeqsVect,outFormat="mat")
This function works like PSEkNUCdi_DNA except that the default value of selectedIdx parameter is different.
PCPseDNC( seqs, selectedIdx = c("Base stacking", "Protein induced deformability", "B-DNA twist", "A-philicity", "Propeller twist", "Duplex stability:(freeenergy)", "DNA denaturation", "Bending stiffness", "Protein DNA twist", "Aida_BA_transition", "Breslauer_dG", "Breslauer_dH", "Electron_interaction", "Hartman_trans_free_energy", "Helix-Coil_transition", "Lisser_BZ_transition", "Polar_interaction", "SantaLucia_dG", "SantaLucia_dS", "Sarai_flexibility", "Stability", "Sugimoto_dG", "Sugimoto_dH", "Sugimoto_dS", "Duplex tability(disruptenergy)", "Stabilising energy of Z-DNA", "Breslauer_dS", "Ivanov_BA_transition", "SantaLucia_dH", "Stacking_energy", "Watson-Crick_interaction", "Dinucleotide GC Content", "Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
PCPseDNC( seqs, selectedIdx = c("Base stacking", "Protein induced deformability", "B-DNA twist", "A-philicity", "Propeller twist", "Duplex stability:(freeenergy)", "DNA denaturation", "Bending stiffness", "Protein DNA twist", "Aida_BA_transition", "Breslauer_dG", "Breslauer_dH", "Electron_interaction", "Hartman_trans_free_energy", "Helix-Coil_transition", "Lisser_BZ_transition", "Polar_interaction", "SantaLucia_dG", "SantaLucia_dS", "Sarai_flexibility", "Stability", "Sugimoto_dG", "Sugimoto_dH", "Sugimoto_dS", "Duplex tability(disruptenergy)", "Stabilising energy of Z-DNA", "Breslauer_dS", "Ivanov_BA_transition", "SantaLucia_dH", "Stacking_energy", "Watson-Crick_interaction", "Dinucleotide GC Content", "Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of dinucleotides. Users can choose the desired indices by their ids or their names in the DI_DNA index file. Default value of this parameter is a vector with ("Base stacking","Protein induced deformability","B-DNA twist","A-philicity", "Propeller twist","Duplex stability:(freeenergy)","DNA denaturation","Bending stiffness", "Protein DNA twist","Aida_BA_transition","Breslauer_dG","Breslauer_dH","Electron_interaction", "Hartman_trans_free_energy","Helix-Coil_transition","Lisser_BZ_transition","Polar_interaction", "SantaLucia_dG","SantaLucia_dS","Sarai_flexibility","Stability","Sugimoto_dG", "Sugimoto_dH","Sugimoto_dS","Duplex tability(disruptenergy)","Stabilising energy of Z-DNA", "Breslauer_dS","Ivanov_BA_transition","SantaLucia_dH","Stacking_energy","Watson-Crick_interaction","Dinucleotide GC Content", "Rise", "Roll", "Shift", "Slide", "Tilt", "Twist") entries. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between dinucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in the range of 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l elements of the APkNCdi descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo nucleotide composition for each physicochemical property of di-nucleotides. We have provided users with the ability to choose among the 148 properties in the di-nucleotide index database.
a feature matrix such that the number of columns is 4^l+lambda and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-PSEkNUCdi_DNA(seqs=fileLNC,l=2,ORF=TRUE,threshold=0.8)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-PSEkNUCdi_DNA(seqs=fileLNC,l=2,ORF=TRUE,threshold=0.8)
This function transforms each di-nucleotide of the sequence to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
PS2_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
PS2_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each di-nucleotide is represented by a string containing 16 characters(0-1). For example, 'AA' = "1000000000000000", 'AC' = "0100000000000000", ..., 'TT'= "0000000000000001" 'logicBin'(logical value): Each amino acid is represented by a vector containing 16 logical entries. For example, 'AA' = c(T,F,F,F,F,F,F,F,F,F,F,F,F,F,F,F), ... 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 16 numerals. For example, 'AA' = c(1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences-1)*16. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song, iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research, (2021).
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PS2_DNA(seqs = LNC50Nuc,outFormat="mat")
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PS2_DNA(seqs = LNC50Nuc,outFormat="mat")
This function transforms each di-ribonucleotide of the sequence to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
PS2_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
PS2_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each di-nucleotide is represented by a string containing 16 characters(0-1). For example, 'AA' = "1000000000000000", 'AC' = "0100000000000000", ..., 'TT'= "0000000000000001" 'logicBin'(logical value): Each amino acid is represented by a vector containing 16 logical entries. For example, 'AA' = c(T,F,F,F,F,F,F,F,F,F,F,F,F,F,F,F), ... 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 16 numerals. For example, 'AA' = c(1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences-1)*16. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song, iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research, (2021).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PS2_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PS2_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
This function transforms each tri-nucleotide of the sequence to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
PS3_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
PS3_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each di-nucleotide is represented by a string containing 64 characters (63 times '0' and one '1'). For example, 'AAA' = "1000000000000000...0", .... 'logicBin'(logical value): Each amino acid is represented by a vector containing 64 logical entries (63 times F and one T). For example, 'AA' = c(T,F,F,F,F,F,F,F,F,F,F,F,F,F,F,F,...,F), ... 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 64 numerals (63 times '0' and one '1'). For example, 'AA' = c(1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences-2)*64. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song, iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research, (2021).
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PS3_DNA(seqs = LNC50Nuc,outFormat="mat")
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PS3_DNA(seqs = LNC50Nuc,outFormat="mat")
This function transforms each tri-ribonucleotide of the sequence to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
PS3_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
PS3_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each di-ribonucleotide is represented by a string containing 64 characters (63 times '0' and one '1'). For example, 'AAA' = "1000000000000000...0", .... 'logicBin'(logical value): Each amino acid is represented by a vector containing 64 logical entries (63 times F and one T). For example, 'AA' = c(T,F,F,F,F,F,F,F,F,F,F,F,F,F,F,F,...,F), ... 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 64 numerals (63 times '0' and one '1'). For example, 'AA' = c(1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences-2)*64. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song, iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research, (2021).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PS3_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PS3_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
This function transforms each 4-nucleotide of the sequence to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
PS4_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
PS4_DNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each di-nucleotide is represented by a string containing 256 characters (255 times '0' and one '1'). For example, 'AAA' = "1000000000000000...0", .... 'logicBin'(logical value): Each amino acid is represented by a vector containing 256 logical entries (255 times F and one T). For example, 'AA' = c(T,F,F,F,F,F,F,F,F,F,F,F,F,F,F,F,...,F), ... 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 256 numerals (255 times '0' and one '1'). For example, 'AA' = c(1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences-3)*256. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song, iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research, (2021).
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PS4_DNA(seqs = LNC50Nuc,outFormat="mat")
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PS4_DNA(seqs = LNC50Nuc,outFormat="mat")
This function transforms each 4-ribonucleotide of the sequence to a binary format. The type of the binary format is determined by the binaryType parameter. For details about each format, please refer to the description of the binaryType parameter.
PS4_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
PS4_RNA( seqs, binaryType = "numBin", label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each di-ribonucleotide is represented by a string containing 256 characters (255 times '0' and one '1'). For example, 'AAA' = "1000000000000000...0", .... 'logicBin'(logical value): Each amino acid is represented by a vector containing 256 logical entries (255 times F and one T). For example, 'AA' = c(T,F,F,F,F,F,F,F,F,F,F,F,F,F,F,F,...,F), ... 'numBin' (numeric bin): Each amino acid is represented by a numeric (i.e., integer) vector containing 256 numerals (255 times '0' and one '1'). For example, 'AA' = c(1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0,...,0) |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences-3)*256. If outFormat is 'txt', all binary values will be written to a the output is written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
Zhen Chen, Pei Zhao, Chen Li, Fuyi Li, Dongxu Xiang, Yong-Zi Chen, Tatsuya Akutsu, Roger J Daly, Geoffrey I Webb, Quanzhi Zhao, Lukasz Kurgan, Jiangning Song, iLearnPlus: a comprehensive and automated machine-learning platform for nucleic acid and protein sequence analysis, prediction and visualization, Nucleic Acids Research, (2021).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PS4_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PS4_RNA(seqs = fileLNC, binaryType="numBin",outFormat="mat")
This function calculates the pseudo amino acid composition (parallel) for each sequence.
PSEAAC( seqs, aaIDX = c("ARGP820101", "HOPT810101", "Mass"), lambda = 30, w = 0.05, l = 1, threshold = 1, label = c() )
PSEAAC( seqs, aaIDX = c("ARGP820101", "HOPT810101", "Mass"), lambda = 30, w = 0.05, l = 1, threshold = 1, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
aaIDX |
is a vector of Ids or indexes of the user-selected physicochemical properties in the aaIndex2 database. The default values of the vector are the hydrophobicity ids and hydrophilicity ids and Mass of residual in the amino acid index file. |
lambda |
is a tuning parameter. Its value indicates the maximum number of spaces between amino acid pairs. The number changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in from 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 20^l elements of the APAAC descriptor. |
threshold |
is a number between (0 , 1]. It deletes aaIndexes which have a correlation bigger than the threshold. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
A feature matrix such that the number of columns is 20^l+(lambda) and the number of rows is equal to the number of sequences.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-PSEAAC(seqs=filePrs,l=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-PSEAAC(seqs=filePrs,l=2)
This function calculates the pseudo electron-ion interaction for each sequence. It creates a feature vector for each sequence. The vector contains a value for each for each tri-nucleotide. The value is computed by multiplying the aggregate value of electron-ion interaction of each nucleotide
PseEIIP(seqs, label = c())
PseEIIP(seqs, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix which the number of rows is equal to the number of sequences and the number of columns is 4^3=64.
Chen, Zhen, et al. "iLearn: an integrated platform and meta-learner for feature engineering, machine-learning analysis and modeling of DNA, RNA and protein sequence data." Briefings in bioinformatics 21.3 (2020): 1047-1057.
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PseEIIP(seqs = LNC50Nuc)
LNCSeqsADR<-system.file("extdata/",package="ftrCOOL") LNC50Nuc<-as.vector(read.csv(paste0(LNCSeqsADR,"/LNC50Nuc.csv"))[,2]) mat<-PseEIIP(seqs = LNC50Nuc)
This function calculates the pseudo-k nucleotide composition(Di) (Parallel) for each sequence.
PSEkNUCdi_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
PSEkNUCdi_DNA( seqs, selectedIdx = c("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of dinucleotides. Users can choose the desired indices by their ids or their names in the DI_DNA file. The default values of the parameter is a vector with ("Rise", "Roll", "Shift", "Slide", "Tilt", "Twist") ids. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between dinucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in the range of 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l elements of the APkNCdi descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo nucleotide composition for each physicochemical property of di-nucleotides. We have provided users with the ability to choose among the 148 properties in the di-nucleotide index database.
a feature matrix such that the number of columns is 4^l+lambda and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-PSEkNUCdi_DNA(seqs=fileLNC,l=2,ORF=TRUE,threshold=0.8)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-PSEkNUCdi_DNA(seqs=fileLNC,l=2,ORF=TRUE,threshold=0.8)
This function calculates the pseudo-k ribonucleotide composition(Di) (Parallel) for each sequence.
PSEkNUCdi_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
PSEkNUCdi_RNA( seqs, selectedIdx = c("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)", "Twist (RNA)"), lambda = 3, w = 0.05, l = 2, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of di-ribonucleotides. Users can choose the desired indices by their ids or their names in the DI_RNA peoperties file. The default value of this parameter is a vector with ("Rise (RNA)", "Roll (RNA)", "Shift (RNA)", "Slide (RNA)", "Tilt (RNA)","Twist (RNA)") ids. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between di-ribonucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It changes in the range of 0 to 1. The default value is 0.5. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l elements of the APkNCdi descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo ribonucleotide composition for each physicochemical property of di-ribonucleotides. We have provided users with the ability to choose among the 22 properties in the di-ribonucleotide index database.
a feature matrix such that the number of columns is 4^l+lambda and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PSEkNUCdi_RNA(seqs=fileLNC,l=2,ORF=TRUE,threshold=0.8)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-PSEkNUCdi_RNA(seqs=fileLNC,l=2,ORF=TRUE,threshold=0.8)
This function calculates pseudo-k nucleotide composition(Tri) (Parallel) for each sequence.
PSEkNUCTri_DNA( seqs, selectedIdx = c("Dnase I", "Bendability (DNAse)"), lambda = 3, w = 0.05, l = 3, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
PSEkNUCTri_DNA( seqs, selectedIdx = c("Dnase I", "Bendability (DNAse)"), lambda = 3, w = 0.05, l = 3, ORF = FALSE, reverseORF = TRUE, threshold = 1, label = c() )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
is a vector of Ids or indices of the desired physicochemical properties of trinucleotides. Users can choose the desired indices by their ids or their names in the TRI_DNA index file. The default value of this parameter is a vector with ("Dnase I", "Bendability (DNAse)") ids. |
lambda |
is a tuning parameter. This integer value shows the maximum limit of spaces between Tri-nucleotide pairs. The Number of spaces changes from 1 to lambda. |
w |
(weight) is a tuning parameter. It can take a value in the range 0 to 1. The default value is 0.05. |
l |
This parameter keeps the value of l in lmer composition. The lmers form the first 4^l elements of the APkNCTri descriptor. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
threshold |
is a number between (0 , 1]. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function computes the pseudo nucleotide composition for each physicochemical property of trinucleotides. We have provided users with the ability to choose among the 12 properties in the tri-nucleotide index database.
a feature matrix such that the number of columns is 4^l+lambda and the number of rows is equal to the number of sequences.
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-PSEkNUCTri_DNA(seqs=fileLNC, l=2,ORF=TRUE,threshold=0.8)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-PSEkNUCTri_DNA(seqs=fileLNC, l=2,ORF=TRUE,threshold=0.8)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type1(PseKRAAC_T1) contains Grp 2 to 20.
PseKRAAC_T1( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 2, label = c() )
PseKRAAC_T1( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 2, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 2=c("CMFILVWY", "AGTSNQDEHRKP"), 3=c("CMFILVWY", "AGTSP", "NQDEHRK"), 4=c("CMFWY", "ILV", "AGTS", "NQDEHRKP"), 5=c("WFYH", "MILV", "CATSP", "G", "NQDERK"), 6=c("WFYH", "MILV", "CATS", "P", "G", "NQDERK"), 7=c("WFYH", "MILV", "CATS", "P", "G", "NQDE", "RK"), 8=c("WFYH", "MILV", "CA", "NTS", "P", "G", "DE", "QRK"), 9=c("WFYH", "MI", "LV", "CA", "NTS", "P", "G", "DE", "QRK"), 10=c("WFY", "ML", "IV", "CA", "TS", "NH", "P", "G", "DE", "QRK"), 11=c("WFY", "ML", "IV", "CA", "TS", "NH", "P", "G", "D", "QE", "RK"), 12=c("WFY", "ML", "IV", "C", "A", "TS", "NH", "P", "G", "D", "QE", "RK"), 13=c("WFY", "ML", "IV", "C", "A", "T", "S", "NH", "P", "G", "D", "QE", "RK"), 14=c("WFY", "ML", "IV", "C", "A", "T", "S", "NH", "P", "G", "D", "QE", "R", "K"), 15=c("WFY", "ML", "IV", "C", "A", "T", "S", "N", "H", "P", "G", "D", "QE", "R", "K"), 16=c("W", "FY", "ML", "IV", "C", "A", "T", "S", "N", "H", "P", "G", "D", "QE", "R", "K"), 17=c("W", "FY", "ML", "IV", "C", "A", "T", "S", "N", "H", "P", "G", "D", "Q", "E", "R", "K"), 18=c("W", "FY", "M", "L", "IV", "C", "A", "T", "S", "N", "H", "P", "G", "D", "Q", "E", "R", "K"), 19=c("W", "F", "Y", "M", "L", "IV", "C", "A", "T", "S", "N", "H", "P", "G", "D", "Q", "E", "R", "K"), 20=c("W", "F", "Y", "M", "L", "I", "V", "C", "A", "T", "S", "N", "H", "P", "G", "D", "Q", "E", "R", "K")
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T1(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T1(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T1(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T1(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type10(PseKRAAC_T10) contains Grp 2-20.
PseKRAAC_T10( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T10( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 2=c('CMFILVWY', 'AGTSNQDEHRKP'), 3=c('CMFILVWY', 'AGTSP', 'NQDEHRK'), 4=c('CMFWY', 'ILV', 'AGTS', 'NQDEHRKP'), 5=c('FWYH', 'MILV', 'CATSP', 'G', 'NQDERK'), 6=c('FWYH', 'MILV', 'CATS', 'P', 'G', 'NQDERK'), 7=c('FWYH', 'MILV', 'CATS', 'P', 'G', 'NQDE', 'RK'), 8=c('FWYH', 'MILV', 'CA', 'NTS', 'P', 'G', 'DE', 'QRK'), 9=c('FWYH', 'ML', 'IV', 'CA', 'NTS', 'P', 'G', 'DE', 'QRK'), 10=c('FWY', 'ML', 'IV', 'CA', 'TS', 'NH', 'P', 'G', 'DE', 'QRK'), 11=c('FWY', 'ML', 'IV', 'CA', 'TS', 'NH', 'P', 'G', 'D', 'QE', 'RK'), 12=c('FWY', 'ML', 'IV', 'C', 'A', 'TS', 'NH', 'P', 'G', 'D', 'QE', 'RK'), 13=c('FWY', 'ML', 'IV', 'C', 'A', 'T', 'S', 'NH', 'P', 'G', 'D', 'QE', 'RK'), 14=c('FWY', 'ML', 'IV', 'C', 'A', 'T', 'S', 'NH', 'P', 'G', 'D', 'QE', 'R', 'K'), 15=c('FWY', 'ML', 'IV', 'C', 'A', 'T', 'S', 'N', 'H', 'P', 'G', 'D', 'QE', 'R', 'K'), 16=c('W', 'FY', 'ML', 'IV', 'C', 'A', 'T', 'S', 'N', 'H', 'P', 'G', 'D', 'QE', 'R', 'K'), 17=c('W', 'FY', 'ML', 'IV', 'C', 'A', 'T', 'S', 'N', 'H', 'P', 'G', 'D', 'Q', 'E', 'R', 'K'), 18=c('W', 'FY', 'M', 'L', 'IV', 'C', 'A', 'T', 'S', 'N', 'H', 'P', 'G', 'D', 'Q', 'E', 'R', 'K'), 19=c('W', 'F', 'Y', 'M', 'L', 'IV', 'C', 'A', 'T', 'S', 'N', 'H', 'P', 'G', 'D', 'Q', 'E', 'R', 'K'), 20=c('W', 'F', 'Y', 'M', 'L', 'I', 'V', 'C', 'A', 'T', 'S', 'N', 'H', 'P', 'G', 'D', 'Q', 'E', 'R', 'K')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T10(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T10(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T10(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T10(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type11(PseKRAAC_T11) contains Grp 2-20.
PseKRAAC_T11( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T11( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 2=c('CFYWMLIV', 'GPATSNHQEDRK'), 3=c('CFYWMLIV', 'GPATS', 'NHQEDRK'), 4=c('CFYW', 'MLIV', 'GPATS', 'NHQEDRK'), 5=c('CFYW', 'MLIV', 'G', 'PATS', 'NHQEDRK'), 6=c('CFYW', 'MLIV', 'G', 'P', 'ATS', 'NHQEDRK'), 7=c('CFYW', 'MLIV', 'G', 'P', 'ATS', 'NHQED', 'RK'), 8=c('CFYW', 'MLIV', 'G', 'P', 'ATS', 'NH', 'QED', 'RK'), 9=c('CFYW', 'ML', 'IV', 'G', 'P', 'ATS', 'NH', 'QED', 'RK'), 10=c('C', 'FYW', 'ML', 'IV', 'G', 'P', 'ATS', 'NH', 'QED', 'RK'), 11=c('C', 'FYW', 'ML', 'IV', 'G', 'P', 'A', 'TS', 'NH', 'QED', 'RK'), 12=c('C', 'FYW', 'ML', 'IV', 'G', 'P', 'A', 'TS', 'NH', 'QE', 'D', 'RK'), 13=c('C', 'FYW', 'ML', 'IV', 'G', 'P', 'A', 'T', 'S', 'NH', 'QE', 'D', 'RK'), 14=c('C', 'FYW', 'ML', 'IV', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'QE', 'D', 'RK'), 15=c('C', 'FYW', 'ML', 'IV', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'QE', 'D', 'R', 'K'), 16=c('C', 'FY', 'W', 'ML', 'IV', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'QE', 'D', 'R', 'K'), 17=c('C', 'FY', 'W', 'ML', 'IV', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'Q', 'E', 'D', 'R', 'K'), 18=c('C', 'FY', 'W', 'M', 'L', 'IV', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'Q', 'E', 'D', 'R', 'K'), 19=c('C', 'F', 'Y', 'W', 'M', 'L', 'IV', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'Q', 'E', 'D', 'R', 'K'), 20=c('C', 'F', 'Y', 'W', 'M', 'L', 'I', 'V', 'G', 'P', 'A', 'T', 'S', 'N', 'H', 'Q', 'E', 'D', 'R', 'K')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T11(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T11(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T11(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T11(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type12(PseKRAAC_T12) contains Grp 2-18,20.
PseKRAAC_T12( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T12( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 2=c('IVMLFWYC', 'ARNDQEGHKPST'), 3=c('IVLMFWC', 'YA', 'RNDQEGHKPST'), 4=c('IVLMFW', 'C', 'YA', 'RNDQEGHKPST'), 5=c('IVLMFW', 'C', 'YA', 'G', 'RNDQEHKPST'), 6=c('IVLMF', 'WY', 'C', 'AH', 'G', 'RNDQEKPST'), 7=c('IVLMF', 'WY', 'C', 'AH', 'GP', 'R', 'NDQEKST'), 8=c('IVLMF', 'WY', 'C', 'A', 'G', 'R', 'Q', 'NDEHKPST'), 9=c('IVLMF', 'WY', 'C', 'A', 'G', 'P', 'H', 'K', 'RNDQEST'), 10=c('IVLM', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'RN', 'DQEKPST'), 11=c('IVLMF', 'W', 'Y', 'C', 'A', 'H', 'G', 'R', 'N', 'Q', 'DEKPST'), 12=c('IVLM', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'T', 'RDEKPS'), 13=c('IVLM', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'DEKST'), 14=c('IVLM', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'K', 'DEST'), 15=c('IVLM', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'K', 'D', 'EST'), 16=c('IVLM', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'K', 'S', 'T', 'DE'), 17=c('IVL', 'M', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'K', 'S', 'T', 'DE'), 18=c('IVL', 'M', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'K', 'S', 'T', 'D', 'E'), 20=c('I', 'V', 'L', 'M', 'F', 'W', 'Y', 'C', 'A', 'H', 'G', 'N', 'Q', 'P', 'R', 'K', 'S', 'T', 'D', 'E')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T12(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T12(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T12(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T12(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type13(PseKRAAC_T13) contains Grp 4,12,17,20.
PseKRAAC_T13( seqs, type = "gap", Grp = 4, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T13( seqs, type = "gap", Grp = 4, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 4=c('ADKERNTSQ', 'YFLIVMCWH', 'G', 'P'), 12=c('A', 'D', 'KER', 'N', 'TSQ', 'YF', 'LIVM', 'C', 'W', 'H', 'G', 'P'), 17=c('A', 'D', 'KE', 'R', 'N', 'T', 'S', 'Q', 'Y', 'F', 'LIV', 'M', 'C', 'W', 'H', 'G', 'P'), 20=c('A', 'D', 'K', 'E', 'R', 'N', 'T', 'S', 'Q', 'Y', 'F', 'L', 'I', 'V', 'M', 'C', 'W', 'H', 'G', 'P')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T13(seqs=filePrs,type="gap",Grp=17,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T13(seqs=filePrs,type="lambda",Grp=17,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T13(seqs=filePrs,type="gap",Grp=17,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T13(seqs=filePrs,type="lambda",Grp=17,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type14(PseKRAAC_T14) contains Grp 2-20.
PseKRAAC_T14( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T14( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 2=c('ARNDCQEGHKPST', 'ILMFWYV'), 3=c('ARNDQEGHKPST', 'C', 'ILMFWYV'), 4=c('ARNDQEGHKPST', 'C', 'ILMFYV', 'W'), 5=c('AGPST', 'RNDQEHK', 'C', 'ILMFYV', 'W'), 6=c('AGPST', 'RNDQEK', 'C', 'H', 'ILMFYV', 'W'), 7=c('ANDGST', 'RQEK', 'C', 'H', 'ILMFYV', 'P', 'W'), 8=c('ANDGST', 'RQEK', 'C', 'H', 'ILMV', 'FY', 'P', 'W'), 9=c('AGST', 'RQEK', 'ND', 'C', 'H', 'ILMV', 'FY', 'P', 'W'), 10=c('AGST', 'RK', 'ND', 'C', 'QE', 'H', 'ILMV', 'FY', 'P', 'W'), 11=c('AST', 'RK', 'ND', 'C', 'QE', 'G', 'H', 'ILMV', 'FY', 'P', 'W'), 12=c('AST', 'RK', 'ND', 'C', 'QE', 'G', 'H', 'IV', 'LM', 'FY', 'P', 'W'), 13=c('AST', 'RK', 'N', 'D', 'C', 'QE', 'G', 'H', 'IV', 'LM', 'FY', 'P', 'W'), 14=c('AST', 'RK', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'IV', 'LM', 'FY', 'P', 'W'), 15=c('A', 'RK', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'IV', 'LM', 'FY', 'P', 'ST', 'W'), 16=c('A', 'RK', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'IV', 'LM', 'F', 'P', 'ST', 'W', 'Y'), 17=c('A', 'R', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'IV', 'LM', 'K', 'F', 'P', 'ST', 'W', 'Y'), 18=c('A', 'R', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'IV', 'LM', 'K', 'F', 'P', 'S', 'T', 'W', 'Y'), 19=c('A', 'R', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'IV', 'L', 'K', 'M', 'F', 'P', 'S', 'T', 'W', 'Y'), 20=c('A', 'R', 'N', 'D', 'C', 'Q', 'E', 'G', 'H', 'I', 'V', 'L', 'K', 'M', 'F', 'P', 'S', 'T', 'W', 'Y')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T14(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T14(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T14(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T14(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type15(PseKRAAC_T15) contains Grp 2-16,20.
PseKRAAC_T15( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T15( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups:
Grp2=c('MFILVAW', 'CYQHPGTSNRKDE'), Grp3=c('MFILVAW', 'CYQHPGTSNRK', 'DE'), Grp4=c('MFILV', 'ACW', 'YQHPGTSNRK', 'DE'), Grp5=c('MFILV', 'ACW', 'YQHPGTSN', 'RK', 'DE'), Grp6=c('MFILV', 'A', 'C', 'WYQHPGTSN', 'RK', 'DE'), Grp7=c('MFILV', 'A', 'C', 'WYQHP', 'GTSN', 'RK', 'DE'), Grp8=c('MFILV', 'A', 'C', 'WYQHP', 'G', 'TSN', 'RK', 'DE'), Grp9=c('MF', 'ILV', 'A', 'C', 'WYQHP', 'G', 'TSN', 'RK', 'DE'), Grp10=c('MF', 'ILV', 'A', 'C', 'WYQHP', 'G', 'TSN', 'RK', 'D', 'E'), Grp11=c('MF', 'IL', 'V', 'A', 'C', 'WYQHP', 'G', 'TSN', 'RK', 'D', 'E'), Grp12=c('MF', 'IL', 'V', 'A', 'C', 'WYQHP', 'G', 'TS', 'N', 'RK', 'D', 'E'), Grp13=c('MF', 'IL', 'V', 'A', 'C', 'WYQHP', 'G', 'T', 'S', 'N', 'RK', 'D', 'E'), Grp14=c('MF', 'I', 'L', 'V', 'A', 'C', 'WYQHP', 'G', 'T', 'S', 'N', 'RK', 'D', 'E'), Grp15=c('MF', 'IL', 'V', 'A', 'C', 'WYQ', 'H', 'P', 'G', 'T', 'S', 'N', 'RK', 'D', 'E'), Grp16=c('MF', 'I', 'L', 'V', 'A', 'C', 'WYQ', 'H', 'P', 'G', 'T', 'S', 'N', 'RK', 'D', 'E'), Grp20=c('M', 'F', 'I', 'L', 'V', 'A', 'C', 'W', 'Y', 'Q', 'H', 'P', 'G', 'T', 'S', 'N', 'R', 'K', 'D', 'E')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T15(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T15(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T15(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T15(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type16(PseKRAAC_T16) contains Grp 2-16,20.
PseKRAAC_T16( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T16( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups:
2=c('IMVLFWY', 'GPCASTNHQEDRK'), 3=c('IMVLFWY', 'GPCAST', 'NHQEDRK'), 4=c('IMVLFWY', 'G', 'PCAST', 'NHQEDRK'), 5=c('IMVL', 'FWY', 'G', 'PCAST', 'NHQEDRK'), 6=c('IMVL', 'FWY', 'G', 'P', 'CAST', 'NHQEDRK'), 7=c('IMVL', 'FWY', 'G', 'P', 'CAST', 'NHQED', 'RK'), 8=c('IMV', 'L', 'FWY', 'G', 'P', 'CAST', 'NHQED', 'RK'), 9=c('IMV', 'L', 'FWY', 'G', 'P', 'C', 'AST', 'NHQED', 'RK'), 10=c('IMV', 'L', 'FWY', 'G', 'P', 'C', 'A', 'STNH', 'RKQE', 'D'), 11=c('IMV', 'L', 'FWY', 'G', 'P', 'C', 'A', 'STNH', 'RKQ', 'E', 'D'), 12=c('IMV', 'L', 'FWY', 'G', 'P', 'C', 'A', 'ST', 'N', 'HRKQ', 'E', 'D'), 13=c('IMV', 'L', 'F', 'WY', 'G', 'P', 'C', 'A', 'ST', 'N', 'HRKQ', 'E', 'D'), 14=c('IMV', 'L', 'F', 'WY', 'G', 'P', 'C', 'A', 'S', 'T', 'N', 'HRKQ', 'E', 'D'), 15=c('IMV', 'L', 'F', 'WY', 'G', 'P', 'C', 'A', 'S', 'T', 'N', 'H', 'RKQ', 'E', 'D'), 16=c('IMV', 'L', 'F', 'W', 'Y', 'G', 'P', 'C', 'A', 'S', 'T', 'N', 'H', 'RKQ', 'E', 'D'), 20=c('I', 'M', 'V', 'L', 'F', 'W', 'Y', 'G', 'P', 'C', 'A', 'S', 'T', 'N', 'H', 'R', 'K', 'Q', 'E', 'D')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T16(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T16(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T16(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T16(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type2(PseKRAAC_T2) contains Grp 2-6,8,15,20.
PseKRAAC_T2( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T2( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups:
2=c('LVIMCAGSTPFYW', 'EDNQKRH'), 3=c('LVIMCAGSTP', 'FYW', 'EDNQKRH'), 4=c('LVIMC', 'AGSTP', 'FYW', 'EDNQKRH'), 5=c('LVIMC', 'AGSTP', 'FYW', 'EDNQ', 'KRH'), 6=c('LVIM', 'AGST', 'PHC', 'FYW', 'EDNQ', 'KR'), 8=c('LVIMC', 'AG', 'ST', 'P', 'FYW', 'EDNQ', 'KR', 'H'), 15=c('LVIM', 'C', 'A', 'G', 'S', 'T', 'P', 'FY', 'W', 'E', 'D', 'N', 'Q', 'KR', 'H'), 20=c('L', 'V', 'I', 'M', 'C', 'A', 'G', 'S', 'T', 'P', 'F', 'Y', 'W', 'E', 'D', 'N', 'Q', 'K', 'R', 'H')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T2(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T2(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T2(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T2(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type3 contain two type: type3A and type3B. 'PseKRAAC_T3A' contains Grp 2-20.
PseKRAAC_T3A( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T3A( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: Grp2=c('AGSPDEQNHTKRMILFYVC', 'W'), Grp3=c('AGSPDEQNHTKRMILFYV', 'W', 'C'), Grp4=c('AGSPDEQNHTKRMIV', 'W', 'YFL', 'C'), Grp5=c('AGSPDEQNHTKR', 'W', 'YF', 'MIVL', 'C'), Grp6=c('AGSP', 'DEQNHTKR', 'W', 'YF', 'MIL', 'VC'), Grp7=c('AGP', 'DEQNH', 'TKRMIV', 'W', 'YF', 'L', 'CS'), Grp8=c('AG', 'DEQN', 'TKRMIV', 'HY', 'W', 'L', 'FP', 'CS'), Grp9=c('AG', 'P', 'DEQN', 'TKRMI', 'HY', 'W', 'F', 'L', 'VCS'), Grp10=c('AG', 'P', 'DEQN', 'TKRM', 'HY', 'W', 'F', 'I', 'L', 'VCS'), Grp11=c('AG', 'P', 'DEQN', 'TK', 'RI', 'H', 'Y', 'W', 'F', 'ML', 'VCS'), Grp12=c('FAS', 'P', 'G', 'DEQ', 'NL', 'TK', 'R', 'H', 'W', 'Y', 'IM', 'VC'), Grp13=c('FAS', 'P', 'G', 'DEQ', 'NL', 'T', 'K', 'R', 'H', 'W', 'Y', 'IM', 'VC'), Grp14=c('FA', 'P', 'G', 'T', 'DE', 'QM', 'NL', 'K', 'R', 'H', 'W', 'Y', 'IV', 'CS'), Grp15=c('FAS', 'P', 'G', 'T', 'DE', 'Q', 'NL', 'K', 'R', 'H', 'W', 'Y', 'M', 'I', 'VC'), Grp16=c('FA', 'P', 'G', 'ST', 'DE', 'Q', 'N', 'K', 'R', 'H', 'W', 'Y', 'M', 'L', 'I', 'VC'), Grp17=c('FA', 'P', 'G', 'S', 'T', 'DE', 'Q', 'N', 'K', 'R', 'H', 'W', 'Y', 'M', 'L', 'I', 'VC'), Grp18=c('FA', 'P', 'G', 'S', 'T', 'DE', 'Q', 'N', 'K', 'R', 'H', 'W', 'Y', 'M', 'L', 'I', 'V', 'C'), Grp19=c('FA', 'P', 'G', 'S', 'T', 'D', 'E', 'Q', 'N', 'K', 'R', 'H', 'W', 'Y', 'M', 'L', 'I', 'V', 'C'), Grp20=c('F', 'A', 'P', 'G', 'S', 'T', 'D', 'E', 'Q', 'N', 'K', 'R', 'H', 'W', 'Y', 'M', 'L', 'I', 'V', 'C')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T3A(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T3A(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T3A(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T3A(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type3 contain two type: type3A and type3B. 'PseKRAAC_T3B' contains Grp 2-20.
PseKRAAC_T3B( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T3B( seqs, type = "gap", Grp = 2, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 2=c('HRKQNEDSTGPACVIM', 'LFYW'), 3=c('HRKQNEDSTGPACVIM', 'LFY', 'W'), 4=c('HRKQNEDSTGPA', 'CIV', 'MLFY', 'W'), 5=c('HRKQNEDSTGPA', 'CV', 'IML', 'FY', 'W'), 6=c('HRKQNEDSTPA', 'G', 'CV', 'IML', 'FY', 'W'), 7=c('HRKQNEDSTA', 'G', 'P', 'CV', 'IML', 'FY', 'W'), 8=c('HRKQSTA', 'NED', 'G', 'P', 'CV', 'IML', 'FY', 'W'), 9=c('HRKQ', 'NED', 'ASTG', 'P', 'C', 'IV', 'MLF', 'Y', 'W'), 10=c('RKHSA', 'Q', 'NED', 'G', 'P', 'C', 'TIV', 'MLF', 'Y', 'W'), 11=c('RKQ', 'NG', 'ED', 'AST', 'P', 'C', 'IV', 'HML', 'F', 'Y', 'W'), 12=c('RKQ', 'ED', 'NAST', 'G', 'P', 'C', 'IV', 'H', 'ML', 'F', 'Y', 'W'), 13=c('RK', 'QE', 'D', 'NG', 'HA', 'ST', 'P', 'C', 'IV', 'ML', 'F', 'Y', 'W'), 14=c('R', 'K', 'QE', 'D', 'NG', 'HA', 'ST', 'P', 'C', 'IV', 'ML', 'F', 'Y', 'W'), 15=c('R', 'K', 'QE', 'D', 'NG', 'HA', 'ST', 'P', 'C', 'IV', 'M', 'L', 'F', 'Y', 'W'), 16=c('R', 'K', 'Q', 'E', 'D', 'NG', 'HA', 'ST', 'P', 'C', 'IV', 'M', 'L', 'F', 'Y', 'W'), 17=c('R', 'K', 'Q', 'E', 'D', 'NG', 'HA', 'S', 'T', 'P', 'C', 'IV', 'M', 'L', 'F', 'Y', 'W'), 18=c('R', 'K', 'Q', 'E', 'D', 'NG', 'HA', 'S', 'T', 'P', 'C', 'I', 'V', 'M', 'L', 'F', 'Y', 'W'), 19=c('R', 'K', 'Q', 'E', 'D', 'NG', 'H', 'A', 'S', 'T', 'P', 'C', 'I', 'V', 'M', 'L', 'F', 'Y', 'W'), 20=c('R', 'K', 'Q', 'E', 'D', 'N', 'G', 'H', 'A', 'S', 'T', 'P', 'C', 'I', 'V', 'M', 'L', 'F', 'Y', 'W')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T3B(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T3B(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T3B(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T3B(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type4(PseKRAAC_T4) contains Grp 5,8,9,11,13,20.
PseKRAAC_T4( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T4( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 5=c('G', 'IVFYW', 'ALMEQRK', 'P', 'NDHSTC'), 8=c('G', 'IV', 'FYW', 'ALM', 'EQRK', 'P', 'ND', 'HSTC'), 9=c('G', 'IV', 'FYW', 'ALM', 'EQRK', 'P', 'ND', 'HS', 'TC'), 11=c('G', 'IV', 'FYW', 'A', 'LM', 'EQRK', 'P', 'ND', 'HS', 'T', 'C'), 13=c('G', 'IV', 'FYW', 'A', 'L', 'M', 'E', 'QRK', 'P', 'ND', 'HS', 'T', 'C'), 20=c('G', 'I', 'V', 'F', 'Y', 'W', 'A', 'L', 'M', 'E', 'Q', 'R', 'K', 'P', 'N', 'D', 'H', 'S', 'T', 'C')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T4(seqs=filePrs,type="gap",Grp=8,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T4(seqs=filePrs,type="lambda",Grp=8,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T4(seqs=filePrs,type="gap",Grp=8,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T4(seqs=filePrs,type="lambda",Grp=8,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type5(PseKRAAC_T5) contains Grp 3,4,8,10,15,20.
PseKRAAC_T5( seqs, type = "gap", Grp = 4, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T5( seqs, type = "gap", Grp = 4, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 3=c('FWYCILMVAGSTPHNQ', 'DE', 'KR'), 4=c('FWY', 'CILMV', 'AGSTP', 'EQNDHKR'), 8=c('FWY', 'CILMV', 'GA', 'ST', 'P', 'EQND', 'H', 'KR'), 10=c('G', 'FYW', 'A', 'ILMV', 'RK', 'P', 'EQND', 'H', 'ST', 'C'), 15=c('G', 'FY', 'W', 'A', 'ILMV', 'E', 'Q', 'RK', 'P', 'N', 'D', 'H', 'S', 'T', 'C'), 20=c('G', 'I', 'V', 'F', 'Y', 'W', 'A', 'L', 'M', 'E', 'Q', 'R', 'K', 'P', 'N', 'D', 'H', 'S', 'T', 'C')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T5(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T5(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T5(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T5(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type6 contain two type: type6A and type6B. 'PseKRAAC_T6A' contains Grp 4,5,20.
PseKRAAC_T6A( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T6A( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 4=c('AGPST', 'CILMV', 'DEHKNQR', 'FYW'), 5=c('AHT', 'CFILMVWY', 'DE', 'GP', 'KNQRS'), 20=c('A', 'C', 'D', 'E', 'F', 'G', 'H', 'I', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'V', 'W', 'Y')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T6A(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T6A(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T6A(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T6A(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type6 contain two type: type6A and type6B. 'PseKRAAC_T6B' contains Grp 5.
PseKRAAC_T6B( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T6B( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: 5=c('AEHKQRST', 'CFILMVWY', 'DN', 'G', 'P')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T6B(seqs=filePrs,type="gap",Grp=5,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T6B(seqs=filePrs,type="lambda",Grp=5,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T6B(seqs=filePrs,type="gap",Grp=5,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T6B(seqs=filePrs,type="lambda",Grp=5,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type7(PseKRAAC_T7) contains Grp 2-20.
PseKRAAC_T7( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T7( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: Grp2=c('C', 'MFILVWYAGTSNQDEHRKP'), Grp3=c('C', 'MFILVWYAKR', 'GTSNQDEHP'), Grp4=c('C', 'KR', 'MFILVWYA', 'GTSNQDEHP'), Grp5=c('C', 'KR', 'MFILVWYA', 'DE', 'GTSNQHP'), Grp6=c('C', 'KR', 'WYA', 'MFILV', 'DE', 'GTSNQHP'), Grp7=c('C', 'KR', 'WYA', 'MFILV', 'DE', 'QH', 'GTSNP'), Grp8=c('C', 'KR', 'WYA', 'MFILV', 'D', 'E', 'QH', 'GTSNP'), Grp9=c('C', 'KR', 'WYA', 'MFILV', 'D', 'E', 'QH', 'TP', 'GSN'), Grp10=c('C', 'KR', 'WY', 'A', 'MFILV', 'D', 'E', 'QH', 'TP', 'GSN'), Grp11=c('C', 'K', 'R', 'WY', 'A', 'MFILV', 'D', 'E', 'QH', 'TP', 'GSN'), Grp12=c('C', 'K', 'R', 'WY', 'A', 'MFILV', 'D', 'E', 'QH', 'TP', 'GS', 'N'), Grp13=c('C', 'K', 'R', 'W', 'Y', 'A', 'MFILV', 'D', 'E', 'QH', 'TP', 'GS', 'N'), Grp14=c('C', 'K', 'R', 'W', 'Y', 'A', 'FILV', 'M', 'D', 'E', 'QH', 'TP', 'GS', 'N'), Grp15=c('C', 'K', 'R', 'W', 'Y', 'A', 'FILV', 'M', 'D', 'E', 'Q', 'H', 'TP', 'GS', 'N'), Grp16=c('C', 'K', 'R', 'W', 'Y', 'A', 'FILV', 'M', 'D', 'E', 'Q', 'H', 'TP', 'G', 'S', 'N'), Grp17=c('C', 'K', 'R', 'W', 'Y', 'A', 'FI', 'LV', 'M', 'D', 'E', 'Q', 'H', 'TP', 'G', 'S', 'N'), Grp18=c('C', 'K', 'R', 'W', 'Y', 'A', 'FI', 'LV', 'M', 'D', 'E', 'Q', 'H', 'T', 'P', 'G', 'S', 'N'), Grp19=c('C', 'K', 'R', 'W', 'Y', 'A', 'F', 'I', 'LV', 'M', 'D', 'E', 'Q', 'H', 'T', 'P', 'G', 'S', 'N'), Grp20=c('C', 'K', 'R', 'W', 'Y', 'A', 'F', 'I', 'L', 'V', 'M', 'D', 'E', 'Q', 'H', 'T', 'P', 'G', 'S', 'N')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T7(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T7(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T7(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T7(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type8(PseKRAAC_T8) contains Grp 2-20.
PseKRAAC_T8( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T8( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: Grp2=c('ADEGKNPQRST', 'CFHILMVWY'), Grp3=c('ADEGNPST', 'CHKQRW', 'FILMVY'), Grp4=c('AGNPST', 'CHWY', 'DEKQR', 'FILMV'), Grp5=c('AGPST', 'CFWY', 'DEN', 'HKQR', 'ILMV'), Grp6=c('APST', 'CW', 'DEGN', 'FHY', 'ILMV', 'KQR'), Grp7=c('AGST', 'CW', 'DEN', 'FY', 'HP', 'ILMV', 'KQR'), Grp8=c('AST', 'CG', 'DEN', 'FY', 'HP', 'ILV', 'KQR', 'MW'), Grp9=c('AST', 'CW', 'DE', 'FY', 'GN', 'HQ', 'ILV', 'KR', 'MP'), Grp10=c('AST', 'CW', 'DE', 'FY', 'GN', 'HQ', 'IV', 'KR', 'LM', 'P'), Grp11=c('AST', 'C', 'DE', 'FY', 'GN', 'HQ', 'IV', 'KR', 'LM', 'P', 'W'), Grp12=c('AST', 'C', 'DE', 'FY', 'G', 'HQ', 'IV', 'KR', 'LM', 'N', 'P', 'W'), Grp13=c('AST', 'C', 'DE', 'FY', 'G', 'H', 'IV', 'KR', 'LM', 'N', 'P', 'Q', 'W'), Grp14=c('AST', 'C', 'DE', 'FL', 'G', 'H', 'IV', 'KR', 'M', 'N', 'P', 'Q', 'W', 'Y'), Grp15=c('AST', 'C', 'DE', 'F', 'G', 'H', 'IV', 'KR', 'L', 'M', 'N', 'P', 'Q', 'W', 'Y'), Grp16=c('AT', 'C', 'DE', 'F', 'G', 'H', 'IV', 'KR', 'L', 'M', 'N', 'P', 'Q', 'S', 'W', 'Y'), Grp17=c('AT', 'C', 'DE', 'F', 'G', 'H', 'IV', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'W', 'Y'), Grp18=c('A', 'C', 'DE', 'F', 'G', 'H', 'IV', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'W', 'Y'), Grp19=c('A', 'C', 'D', 'E', 'F', 'G', 'H', 'IV', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'W', 'Y'), Grp20=c('A', 'C', 'D', 'E', 'F', 'G', 'H', 'I', 'V', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'W', 'Y')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T8(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T8(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T8(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T8(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
There are 16 types of PseKRAAC function. In the functions, a (user-selected) grouping of the amino acids might be used to reduce the amino acid alphabet. Also, the functions have a type parameter. The parameter determines the protein sequence analyses which can be either gap or lambda-correlation. PseKRAAC_type9(PseKRAAC_T9) contains Grp 2-20.
PseKRAAC_T9( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
PseKRAAC_T9( seqs, type = "gap", Grp = 5, GapOrLambdaValue = 2, k = 4, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
type |
This parameter has two valid value "lambda" and "gap". "lambda" calls lambda_model function and "gap" calls gap_model function. |
Grp |
is a numeric value. It shows the id of an amino acid group. Please find the available groups in the detail section. |
GapOrLambdaValue |
is an integer. If type is gap, this value shows number of gaps between two k-mers. If type is lambda, the value of GapOrLambdaValue shows the number of gaps between each two amino acids of k-mers. |
k |
This parameter keeps the value of k in k-mer. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Groups: Grp2=c('ADEGKNPQRST', 'CFHILMVWY'), Grp3=c('ADEGNPST', 'CHKQRW', 'FILMVY'), Grp4=c('AGNPST', 'CHWY', 'DEKQR', 'FILMV'), Grp5=c('AGPST', 'CFWY', 'DEN', 'HKQR', 'ILMV'), Grp6=c('APST', 'CW', 'DEGN', 'FHY', 'ILMV', 'KQR'), Grp7=c('AGST', 'CW', 'DEN', 'FY', 'HP', 'ILMV', 'KQR'), Grp8=c('AST', 'CG', 'DEN', 'FY', 'HP', 'ILV', 'KQR', 'MW'), Grp9=c('AST', 'CW', 'DE', 'FY', 'GN', 'HQ', 'ILV', 'KR', 'MP'), Grp10=c('AST', 'CW', 'DE', 'FY', 'GN', 'HQ', 'IV', 'KR', 'LM', 'P'), Grp11=c('AST', 'C', 'DE', 'FY', 'GN', 'HQ', 'IV', 'KR', 'LM', 'P', 'W'), Grp12=c('AST', 'C', 'DE', 'FY', 'G', 'HQ', 'IV', 'KR', 'LM', 'N', 'P', 'W'), Grp13=c('AST', 'C', 'DE', 'FY', 'G', 'H', 'IV', 'KR', 'LM', 'N', 'P', 'Q', 'W'), Grp14=c('AST', 'C', 'DE', 'FL', 'G', 'H', 'IV', 'KR', 'M', 'N', 'P', 'Q', 'W', 'Y'), Grp15=c('AST', 'C', 'DE', 'F', 'G', 'H', 'IV', 'KR', 'L', 'M', 'N', 'P', 'Q', 'W', 'Y'), Grp16=c('AT', 'C', 'DE', 'F', 'G', 'H', 'IV', 'KR', 'L', 'M', 'N', 'P', 'Q', 'S', 'W', 'Y'), Grp17=c('AT', 'C', 'DE', 'F', 'G', 'H', 'IV', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'W', 'Y'), Grp18=c('A', 'C', 'DE', 'F', 'G', 'H', 'IV', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'W', 'Y'), Grp19=c('A', 'C', 'D', 'E', 'F', 'G', 'H', 'IV', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'W', 'Y'), Grp20=c('A', 'C', 'D', 'E', 'F', 'G', 'H', 'I', 'V', 'K', 'L', 'M', 'N', 'P', 'Q', 'R', 'S', 'T', 'W', 'Y')
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (Grp)^k.
Zuo, Yongchun, et al. "PseKRAAC: a flexible web server for generating pseudo K-tuple reduced amino acids composition." Bioinformatics 33.1 (2017): 122-124.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T9(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T9(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat1<-PseKRAAC_T9(seqs=filePrs,type="gap",Grp=4,GapOrLambdaValue=3,k=2) mat2<-PseKRAAC_T9(seqs=filePrs,type="lambda",Grp=4,GapOrLambdaValue=3,k=2)
This functions receives as input PSSM matrices (which are created by PSI-BLAST software) and converts them into feature vectors.
PSSM(dirPath, outFormat = "mat", outputFileDist = "")
PSSM(dirPath, outFormat = "mat", outputFileDist = "")
dirPath |
Path of the directory which contains all output files of PSI-BLAST. Each file belongs to a sequence. |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*(20) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
dir = tempdir() ad<-paste0(dir,"/pssm.txt") PSSMdir<-system.file("testForder",package="ftrCOOL") PSSMdir<-paste0(PSSMdir,"/PSSMdir/") mat<-PSSM(PSSMdir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ad<-paste0(dir,"/pssm.txt") PSSMdir<-system.file("testForder",package="ftrCOOL") PSSMdir<-paste0(PSSMdir,"/PSSMdir/") mat<-PSSM(PSSMdir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function works like PSTNPss_DNA except that it considers T as A and G as C. So it converts Ts in the sequence to A and Gs to C. Then, it works with 2 alphabets A and C. For more details refer to PSTNPss_DNA.
PSTNPds(seqs, pos, neg, label = c())
PSTNPds(seqs, pos, neg, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
pos |
is a fasta file containing nucleotide sequences. Each sequence starts with '>'. Also, the value of this parameter can be a string vector. The sequences are positive sequences in the training model. |
neg |
is a fasta file containing nucleotide sequences. Each sequence starts with '>'. Also, the value of this parameter can be a string vector. The sequences are negative sequences in the training model. |
label |
is an optional parameter. It is a vector whose length is equal to the number of sequences. It shows the class of each entry (i.e., sequence). |
It returns a feature matrix. The number of columns is equal to the length of sequences minus two and the number of rows is equal to the number of sequences.
The length of the sequences in positive and negative data sets and the input sets should be equal.
Chen, Zhen, et al. "iLearn: an integrated platform and meta-learner for feature engineering, machine-learning analysis and modeling of DNA, RNA and protein sequence data." Briefings in bioinformatics 21.3 (2020): 1047-1057.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/posData.txt"),alphabet="dna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/negData.txt"),alphabet="dna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testData.txt"),alphabet="dna") PSTNPds(seqs=seqs,pos=posSeqs[1],neg=negSeqs[1])
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/posData.txt"),alphabet="dna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/negData.txt"),alphabet="dna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testData.txt"),alphabet="dna") PSTNPds(seqs=seqs,pos=posSeqs[1],neg=negSeqs[1])
The inputs to this function are positive and negative data sets and a set of sequences. The output of the function is a matrix of feature vectors. The number of rows of the output matrix is equal to the number of sequences. The feature vector for an input sequence with length L is [u(1),u(2),...u(L-2)]. For each input sequence, u(1) is calculated by subtracting the frequency of sequences (which start with the same trinucleotides as the input sequence) in the positive set with those starting with the same trinucleotide in the negative set. We compute u(i) like u(1) with the exception that instead of the first trinucleotide, the ith trinucletide is considered.
PSTNPss_DNA(seqs, pos, neg, label = c())
PSTNPss_DNA(seqs, pos, neg, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
pos |
is a fasta file containing nucleotide sequences. Each sequence starts with '>'. Also, the value of this parameter can be a string vector. The sequences are positive sequences in the training model. |
neg |
is a fasta file containing nucleotide sequences. Each sequence starts with '>'. Also, the value of this parameter can be a string vector. |
label |
is an optional parameter. It is a vector whose length is equal to the number of sequences. It shows the class of each entry (i.e., sequence). |
It returns a feature matrix. The number of columns is equal to the length of sequences minus two and the number of rows is equal to the number of sequences.
The length of the sequences in positive and negative data sets and the input sets should be equal.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/posDNA.txt"),alphabet="dna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/negDNA.txt"),alphabet="dna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/DNA_testing.txt"),alphabet="dna") mat=PSTNPss_DNA(seqs=seqs,pos=posSeqs,neg=negSeqs)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/posDNA.txt"),alphabet="dna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/negDNA.txt"),alphabet="dna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/DNA_testing.txt"),alphabet="dna") mat=PSTNPss_DNA(seqs=seqs,pos=posSeqs,neg=negSeqs)
The inputs to this function are positive and negative data sets and a set of sequences. The output of the function is a matrix of feature vectors. The number of rows of the output matrix is equal to the number of sequences. The feature vector for an input sequence with length L is [u(1),u(2),...u(L-2)]. For each input sequence, u(1) is calculated by subtracting the frequency of sequences (which start with the same tri-ribonucleotides as the input sequence) in the positive set with those starting with the same tri-ribonucleotide in the negative set. We compute u(i) like u(1) with the exception that instead of the first tri-ribonucleotide, the ith tri-ribonucletide is considered.
PSTNPss_RNA(seqs, pos, neg, label = c())
PSTNPss_RNA(seqs, pos, neg, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
pos |
is a fasta file containing ribonucleotide sequences. Each sequence starts with '>'. Also, the value of this parameter can be a string vector. The sequences are positive sequences in the training model |
neg |
is a fasta file containing ribonucleotide sequences. Each sequence starts with '>'. Also, the value of this parameter can be a string vector. |
label |
is an optional parameter. It is a vector whose length is equal to the number of sequences. It shows the class of each entry (i.e., sequence). |
It returns a feature matrix. The number of columns is equal to the length of sequences minus two and the number of rows is equal to the number of sequences.
The length of the sequences in positive and negative data sets and the input sets should be equal.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/pos2RNA.txt"),alphabet="rna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/neg2RNA.txt"),alphabet="rna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testSeq2RNA.txt"),alphabet="rna") PSTNPss_RNA(seqs=seqs,pos=posSeqs,neg=negSeqs)
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") posSeqs<-fa.read(file=paste0(ptmSeqsADR,"/pos2RNA.txt"),alphabet="rna") negSeqs<-fa.read(file=paste0(ptmSeqsADR,"/neg2RNA.txt"),alphabet="rna") seqs<-fa.read(file=paste0(ptmSeqsADR,"/testSeq2RNA.txt"),alphabet="rna") PSTNPss_RNA(seqs=seqs,pos=posSeqs,neg=negSeqs)
This function computes the quasi-sequence-order for sequences. It is for amino acid pairs with d distances (d can be any number between 1 and 20). First, it calculates the frequencies of each amino acid ("A", "C",..., "Y"). Then, it normalizes the frequencies by dividing the frequency of an amino acid to the frequency of all amino acids plus the sum of tau values which is multiplied by W. tau values are given by function SOCNumber. For d bigger than 20, it computes tau for d in the range "1 to (nlag-20) * W" and normalizes them like before.
QSOrder(seqs, nlag = 25, W = 0.1, label = c())
QSOrder(seqs, nlag = 25, W = 0.1, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
nlag |
is a numeric value which shows the maximum distance between two amino acids. Distances can be 1, 2, ..., or nlag. |
W |
(weight) is a tuning parameter. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
Please find details about tau in function SOCNumber.
It returns a feature matrix which the number of rows equals to the number of sequences and the number of columns is (nlag*2). For each distance d, there are two values. One value for Granthman and another one for Schneider distance.
For d between 21 to nlag, the function calculates tau values for (d-20) to (nlag-20).
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-QSOrder(seqs=filePrs,nlag=25)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-QSOrder(seqs=filePrs,nlag=25)
This function reads a directory that contains the output files of SPINE-X. It gets the directory path as the input and returns a list of vectors. Each vector includes the ASA predicted value for amino acids of the sequence.
readASAdir(dirPath)
readASAdir(dirPath)
dirPath |
path of the directory which contains all the output files of SPINE-X. Each file belongs to a sequence. |
a list of vectors with all the predicted ASA value for each amino acid. The length of the list is the number of files(sequences) and the length of each vector is (length of sequence(i))
PredASAdir<-system.file("testForder",package="ftrCOOL") PredASAdir<-paste0(PredASAdir,"/ASAdir/") PredVectASA<-readASAdir(PredASAdir)
PredASAdir<-system.file("testForder",package="ftrCOOL") PredASAdir<-paste0(PredASAdir,"/ASAdir/") PredVectASA<-readASAdir(PredASAdir)
This function reads a directory that contains the output VSL2 files. It gets the directory path as the input and returns a list of vectors. Each vector includes the disorder/order type for the amino acids of the sequence.
readDisDir(dirPath)
readDisDir(dirPath)
dirPath |
the path of a directory which contains all the VSL2 output files. |
a list of vectors with all the predicted disorder/order type for each amino acid. The length of the list is equal to the number of files(sequences) and the length of each vector is the length of the sequence(i).
PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") listPredVect<-readDisDir(PredDisdir)
PredDisdir<-system.file("testForder",package="ftrCOOL") PredDisdir<-paste0(PredDisdir,"/Disdir/") listPredVect<-readDisDir(PredDisdir)
This function reads a directory that contains the output psi-blast. It gets the directory path as the input and returns a list of vectors. Each vector includes the type for the amino acids of the sequence.
readPSSMdir(dirPath)
readPSSMdir(dirPath)
dirPath |
the path of a directory which contains all the VSL2 output files. |
a list of vectors with all the predicted disorder/order type for each amino acid. The length of the list is equal to the number of files(sequences) and the length of each vector is the length of the sequence(i).
pssmDir<-system.file("testForder",package="ftrCOOL") pssmDir<-paste0(pssmDir,"/PSSMdir/") listPredVect<-readPSSMdir(pssmDir)
pssmDir<-system.file("testForder",package="ftrCOOL") pssmDir<-paste0(pssmDir,"/PSSMdir/") listPredVect<-readPSSMdir(pssmDir)
This function reads a directory that contains the output files of PSIPRED It gets the directory path as the input and returns a list of vectors. Each vector contains the secondary structure of the amino acids in a peptide/protein sequence.
readss2Dir(dirPath)
readss2Dir(dirPath)
dirPath |
The path of the directory which contains all predss2 files. Each file belongs to a sequence. |
returns a list of vectors with all the predicted secondary structure for each amino acid. The length of the list is the number of files(sequences) and the length of each vector is (length sequence(i))
PredSS2dir<-system.file("testForder",package="ftrCOOL") PredSS2dir<-paste0(PredSS2dir,"/ss2Dir/") listPredVect<-readss2Dir(PredSS2dir)
PredSS2dir<-system.file("testForder",package="ftrCOOL") PredSS2dir<-paste0(PredSS2dir,"/ss2Dir/") listPredVect<-readss2Dir(PredSS2dir)
This function reads a directory that contains the output files of SPINE-X. It gets the directory path as the input and returns a list of vectors. Each vector includes the phi and psi angle of the amino acids of the sequence.
readTorsionDir(dirPath)
readTorsionDir(dirPath)
dirPath |
The path of the directory which contains all output files of SPINE-X. Each file belongs to a sequence. |
returns a list of vectors with all the predicted phi and psi angles for each amino acid. The length of the list is the number of files(sequences) and the length of each vector is (2(phi-psi)*length sequence(i)).
PredTorsioNdir<-system.file("testForder",package="ftrCOOL") PredTorsioNdir<-paste0(PredTorsioNdir,"/TorsioNdir/") PredVectASA<-readTorsionDir(PredTorsioNdir)
PredTorsioNdir<-system.file("testForder",package="ftrCOOL") PredTorsioNdir<-paste0(PredTorsioNdir,"/TorsioNdir/") PredVectASA<-readTorsionDir(PredTorsioNdir)
This function returns the reverse compelement of a dna sequence.
revComp(seq, outputType = "str")
revComp(seq, outputType = "str")
seq |
is a dna sequence. |
outputType |
this parameter can take two values: 'char' or 'str'. If outputType is 'str', the reverse complement sequence of the input sequence is returned as a string. Otherwise, a vector of characters which represent the reverse complement is returned. Default value is 'str'. |
The reverse complement of the input sequence.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) Seq<-ptmSeqsVect[1] revCompSeq<-revComp(seq=Seq,outputType="char")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) Seq<-ptmSeqsVect[1] revCompSeq<-revComp(seq=Seq,outputType="char")
This function splits the input sequence into three parts. The first part is N-terminal and the third part is C-terminal and middle part contains all amino acids between these two part. N-terminal will be determined by the first numNterm amino acid in the sequences and C-terminal is determined by numCterm of the last amino acids in the sequence. Users should enter numNterm and numCterm parameters. Their default value is 25. The function calculates kAAComposition for each of the three parts.
SAAC(seqs, k = 1, numNterm = 5, numCterm = 5, normalized = TRUE, label = c())
SAAC(seqs, k = 1, numNterm = 5, numCterm = 5, normalized = TRUE, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
shows which type of amino acid composition applies to the parts. For example, the amino acid composition is applied when k=1 and when k=2, the dipeptide Composition is applied. |
numNterm |
shows how many amino acids should be considered for N-terminal. |
numCterm |
shows how many amino acids should be considered for C-terminal. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
It returns a feature matrix. The number of rows is equal to the number of sequences. The number of columns is (3*(20^k)).
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-SAAC(seqs=filePrs,k=1,numNterm=15,numCterm=15)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-SAAC(seqs=filePrs,k=1,numNterm=15,numCterm=15)
In this function, amino acids are first grouped into a user-defined category. Later, the splitted amino Acid composition is computed. Please note that this function differs from SAAC which works on individual amino acids.
SGAAC( seqs, k = 1, numNterm = 25, numCterm = 25, Grp = "locFus", normalized = TRUE, label = c() )
SGAAC( seqs, k = 1, numNterm = 25, numCterm = 25, Grp = "locFus", normalized = TRUE, label = c() )
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
k |
shows which type of amino acid composition applies to the parts. For example, the amino acid composition is applied when k=1 and when k=2, the dipeptide Composition is applied. |
numNterm |
shows how many amino acids should be considered for N-terminal. |
numCterm |
shows how many amino acids should be considered for C-terminal. |
Grp |
is a list of vectors containig amino acids. Each vector represents a category. Users can define a customized amino acid grouping, provided that the sum of all amino acids is 20 and there is no repeated amino acid in the groups. Also, users can choose 'cTriad'(conjointTriad), 'locFus', or 'aromatic'. Each option provides specific information about the type of an amino acid grouping. |
normalized |
is a logical parameter. When it is FALSE, the return value of the function does not change. Otherwise, the return value is normalized using the length of the sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
It returns a feature matrix. The number of rows is equal to the number of sequences. The number of columns is 3*((number of groups)^k).
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-SGAAC(seqs=filePrs,k=1,numNterm=15,numCterm=15,Grp="aromatic")
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-SGAAC(seqs=filePrs,k=1,numNterm=15,numCterm=15,Grp="aromatic")
This function uses dissimilarity matrices Grantham and Schneider to compute the dissimilarity between amino acid pairs. The distance between amino acid pairs is determined by d which varies between 1 to nlag. For each d, it computes the sum of the dissimilarities of all amino acid pairs. The sum shows the value of tau for a value d. The feature vector contains the values of taus for both matrices. Thus, the length of the feature vector is equal to nlag*2.
SOCNumber(seqs, nlag = 30, label = c())
SOCNumber(seqs, nlag = 30, label = c())
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
nlag |
is a numeric value which shows the maximum distance between two amino acids. Distances can be 1, 2, ..., or nlag. Defult is 30. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
It returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is (nlag*2). For each distance d, there are two values. One value for Granthman and another one for Schneider distance.
When d=1, the pairs of amino acids have no gap and when d=2, there is one gap between the amino acid pairs in the sequence. It will repeat likewise for other values of d.
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-SOCNumber(seqs=filePrs,nlag=25)
filePrs<-system.file("extdata/proteins.fasta",package="ftrCOOL") mat<-SOCNumber(seqs=filePrs,nlag=25)
This function works based on the output of PSIPRED which predicts the secondary structure of the amino acids in a sequence. The output of the PSIPRED is a tab-delimited file which contains the secondary structure in the third column. SSEB gives a binary number (i.e., '001'='H','010'=E','100'='C') for each amino acid.
SSEB(dirPath, binaryType = "numBin", outFormat = "mat", outputFileDist = "")
SSEB(dirPath, binaryType = "numBin", outFormat = "mat", outputFileDist = "")
dirPath |
Path of the directory which contains all output files of PSIPRED. Each file belongs to a sequence. |
binaryType |
It can take any of the following values: ('strBin','logicBin','numBin'). 'strBin'(String binary): each structure is represented by a string containing 3 characters(0-1). Helix = "001" , Extended = "010" , coil = "100". 'logicBin'(logical value): Each structure is represented by a vector containing 3 logical entries. Helix = c(FALSE,FALSE,TRUE) , Extended = c(FALSE,TRUE,FALSE) , Coil = c(TRUE,FALSE,FALSE). 'numBin' (numeric bin): Each structure is represented by a numeric (i.e., integer) vector containing 3 numerals. Helix = c(0,0,1) , Extended = c(0,1,0) , coil = c(1,0,0). |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
This function converts each amino acid to a 3-bit value, such that 2 bits are 0 and 1 bit is 1. The position of 1 shows the type of the secondary structure of the amino acids in the protein/peptide. In this function, '001' is used to show Helix structure, '010' to show Extended structure and '100' to show coil structure.
The output is different depending on the outFormat parameter ('mat' or 'txt'). If outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and if binaryType is 'strBin', the number of columns is the length of the sequences. Otherwise, it is equal to (length of the sequences)*3. If outFormat is 'txt', all binary values will be written to a tab-delimited file. Each line in the file shows the binary format of a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in the outFormat parameter for sequences with different lengths. Warning: If the outFormat is set to 'mat' for sequences with different lengths, it returns an error. It is noteworthy that 'txt' format is not usable for machine learning purposes.
dir = tempdir() ad<-paste0(dir,"/SSEB.txt") Predss2dir<-system.file("testForder",package="ftrCOOL") Predss2dir<-paste0(Predss2dir,"/ss2Dir/") mat<-SSEB(Predss2dir,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ad<-paste0(dir,"/SSEB.txt") Predss2dir<-system.file("testForder",package="ftrCOOL") Predss2dir<-paste0(Predss2dir,"/ss2Dir/") mat<-SSEB(Predss2dir,binaryType="numBin",outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function works based on the output of PSIPRED which predicts the secondary structure of the amino acids in a sequence. The output of the PSIPRED is a tab-delimited file which contains the secondary structure in the third column. SSEC returns the frequency of the secondary structures (i.e., Helix, Extended, Coil) of the sequences.
SSEC(dirPath)
SSEC(dirPath)
dirPath |
Path of the directory which contains all output files of PSIPRED. Each file belongs to a sequence. |
It returns a feature matrix which the number of rows is the number of sequences and the number of columns is 3. The first column shows the number of amino acids which participate in the coil structure. The second column shows the number of amino acids in the extended structure and the last column shows the number of amino acids in the helix structure.
Predss2dir<-system.file("testForder",package="ftrCOOL") Predss2dir<-paste0(Predss2dir,"/ss2Dir/") mat<-SSEC(Predss2dir)
Predss2dir<-system.file("testForder",package="ftrCOOL") Predss2dir<-paste0(Predss2dir,"/ss2Dir/") mat<-SSEC(Predss2dir)
This function works based on the output of PSIPRED which predicts the secondary structure of the amino acids in a sequence. The output of the PSIPRED is a tab-delimited file which contains the secondary structure in the third column. The function represent amino acids in the helix structure by 'H', amino acids in the extended structure by 'E', and amino acids in the coil structure by 'C'.
SSES(dirPath, outFormat = "mat", outputFileDist = "")
SSES(dirPath, outFormat = "mat", outputFileDist = "")
dirPath |
Path of the directory which contains all output files of PSIPRED. Each file belongs to a sequence. |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
The output depends on the outFormat which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same lengths such that the number of columns is equal to the length of the sequences and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for the sequences with the same lengths. However, the users can use 'txt' option in the outFormat parameter for sequences with different lengths. Warning: If the outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when the output format is 'txt', the label information is not displayed in the text file. It is noteworthy that, 'txt' format is not usable for machine learning purposes.
dir = tempdir() ad<-paste0(dir,"/simpleSSE.txt") Predss2dir<-system.file("testForder",package="ftrCOOL") Predss2dir<-paste0(Predss2dir,"/ss2Dir/") mat<-SSES(Predss2dir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ad<-paste0(dir,"/simpleSSE.txt") Predss2dir<-system.file("testForder",package="ftrCOOL") Predss2dir<-paste0(Predss2dir,"/ss2Dir/") mat<-SSES(Predss2dir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
The inputs to this function are phi and psi angles of each amino acid in the sequence. We use the output of SPINE-X software to obtain the angles. Further, the TA function replaces each amino acid of the sequence with a vector. The vector contain two elements: The phi and psi angles.
TorsionAngle(dirPath, outFormat = "mat", outputFileDist = "")
TorsionAngle(dirPath, outFormat = "mat", outputFileDist = "")
dirPath |
Path of the directory which contains all output files of SPINE-X. Each file belongs to a sequence. |
outFormat |
It can take two values: 'mat' (which stands for matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
It shows the path and name of the 'txt' output file. |
The output is differnet depending on the outFormat parameter ('mat' or 'txt'). If the outFormat is set to 'mat', it returns a feature matrix for sequences with the same lengths. The number of rows is equal to the number of sequences and the number of columns is (length of the sequence)*2. If the outFormat is set to 'txt', all binary values will be writen in a 'txt' file. Each row belongs to a sequence.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If the outFormat is set to 'mat' for sequences with different lengths, it returns an error. It is noteworthy that 'txt' format is not usable for machine learning purposes.
dir = tempdir() ad<-paste0(dir,"/ta.txt") PredTorsioNdir<-system.file("testForder",package="ftrCOOL") PredTorsioNdir<-paste0(PredTorsioNdir,"/TorsioNdir/") mat<-TorsionAngle(PredTorsioNdir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
dir = tempdir() ad<-paste0(dir,"/ta.txt") PredTorsioNdir<-system.file("testForder",package="ftrCOOL") PredTorsioNdir<-paste0(PredTorsioNdir,"/TorsioNdir/") mat<-TorsionAngle(PredTorsioNdir,outFormat="txt",outputFileDist=ad) unlink("dir", recursive = TRUE)
This function replaces trinucleotides in a sequence with their physicochemical properties which is multiplied by normalized frequency of that tri-nucleotide.
TPCP_DNA( seqs, selectedIdx = c("Dnase I", "Bendability (DNAse)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
TPCP_DNA( seqs, selectedIdx = c("Dnase I", "Bendability (DNAse)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedIdx |
TPCP_DNA function works based on physicochemical properties. Users, select the properties by their ids or indexes in TRI_DNA index file. The default values of the vector are the ids in "Dnase I", "Bendability (DNAse)". |
threshold |
is a number between 0 to 1. In selectedIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
There are 12 physicochemical indexes in the trinucleotide database.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-2)*(number of selected trinucleotide properties) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes if sequences have different sizes. Otherwise 'txt' format is also usable for machine learning purposes.
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-TPCP_DNA(seqs = fileLNC,threshold=1,outFormat="mat")
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-TPCP_DNA(seqs = fileLNC,threshold=1,outFormat="mat")
This function replaces trinucleotides in a sequence with their physicochemical properties in the trinucleotide index file.
TriNUCindex_DNA( seqs, selectedNucIdx = c("Dnase I", "Bendability (DNAse)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
TriNUCindex_DNA( seqs, selectedNucIdx = c("Dnase I", "Bendability (DNAse)"), threshold = 1, label = c(), outFormat = "mat", outputFileDist = "" )
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
selectedNucIdx |
TriNucIndex function works based on physicochemical properties. Users, select the properties by their ids or indexes in TRI_DNA index file. The default values of the vector are the ids in "Dnase I", "Bendability (DNAse)". |
threshold |
is a number between 0 to 1. In selectedNucIdx, indices with a correlation higher than the threshold will be deleted. The default value is 1. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
There are 12 physicochemical indexes in the trinucleotide database.
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length-2)*(number of selected trinucleotide properties) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes.
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-TriNUCindex_DNA(seqs = fileLNC,threshold=1,outFormat="mat")
fileLNC<-system.file("extdata/Athaliana1.fa",package="ftrCOOL") vect<-TriNUCindex_DNA(seqs = fileLNC,threshold=1,outFormat="mat")
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of nucleotides, di-nucleotides, or tri-nucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve12bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve12bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 12.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve12bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve12bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of ribonucleotides, di-ribonucleotides, or tri-ribonucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve12bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve12bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 12.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve12bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve12bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of nucleotides, di-nucleotides, or tri-nucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve144bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve144bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 144.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve144bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve144bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of ribonucleotides, di-ribonucleotides, or tri-ribonucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve144bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve144bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 144.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve144bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve144bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of nucleotides, di-nucleotides, or tri-nucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve36bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve36bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 36.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve36bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve36bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of ribonucleotides, di-ribonucleotides, or tri-ribonucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve36bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve36bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 36.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve36bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve36bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of nucleotides, di-nucleotides, or tri-nucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve48bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve48bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 48.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve48bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve48bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of ribo ribonucleotides, di-ribonucleotides, or tri-ribonucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve48bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve48bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 48.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve48bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve48bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of nucleotides, di-nucleotides, or tri-nucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve9bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve9bit_DNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing nucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a nucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 9.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve9bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Athaliana_LNCRNA.fa",package="ftrCOOL") mat<-Zcurve9bit_DNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
These group of functions (Zcurve (9, 12, 36, 48, 144)_bit) function calculates the Z-curves. Z-curves are based on freqiencies of ribo ribonucleotides, di-ribonucleotides, or tri-ribonucleotides and their positions on the sequences. For more information about the methods please refer to reference part.
Zcurve9bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
Zcurve9bit_RNA(seqs, ORF = FALSE, reverseORF = TRUE, label = c())
seqs |
is a FASTA file containing ribonucleotide sequences. The sequences start with '>'. Also, seqs could be a string vector. Each element of the vector is a ribonucleotide sequence. |
ORF |
(Open Reading Frame) is a logical parameter. If it is set to true, ORF region of each sequence is considered instead of the original sequence (i.e., 3-frame). |
reverseORF |
is a logical parameter. It is enabled only if ORF is true. If reverseORF is true, ORF region will be searched in the sequence and also in the reverse complement of the sequence (i.e., 6-frame). |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
This function returns a feature matrix. The number of rows is equal to the number of sequences and the number of columns is 9.
Gao,F. and Zhang,C.T. Comparison of various algorithms for recognizing short coding sequences of human genes. Bioinformatics, (2004).
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve9bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
fileLNC<-system.file("extdata/Carica_papaya101RNA.txt",package="ftrCOOL") mat<-Zcurve9bit_RNA(seqs=fileLNC,ORF=TRUE,reverseORF=FALSE)
This function converts the amino acids of a sequence to five physicochemical descriptor variables which were developed by Sandberg et al. in 1998. The Z-SCALE function can be applied to encode peptides of equal length.
zSCALE(seqs, label = c(), outFormat = "mat", outputFileDist = "")
zSCALE(seqs, label = c(), outFormat = "mat", outputFileDist = "")
seqs |
is a FASTA file with amino acid sequences. Each sequence starts with a '>' character. Also, seqs could be a string vector. Each element of the vector is a peptide/protein sequence. |
label |
is an optional parameter. It is a vector whose length is equivalent to the number of sequences. It shows the class of each entry (i.e., sequence). |
outFormat |
(output format) can take two values: 'mat'(matrix) and 'txt'. The default value is 'mat'. |
outputFileDist |
shows the path and name of the 'txt' output file. |
The output depends on the outFormat parameter which can be either 'mat' or 'txt'. If outFormat is 'mat', the function returns a feature matrix for sequences with the same length such that the number of columns is (sequence length)*(5) and the number of rows is equal to the number of sequences. If the outFormat is 'txt', the output is written to a tab-delimited file.
This function is provided for sequences with the same lengths. Users can use 'txt' option in outFormat parameter for sequences with different lengths. Warning: If outFormat is set to 'mat' for sequences with different lengths, it returns an error. Also, when output format is 'txt', label information is not shown in the text file. It is noteworthy that 'txt' format is not usable for machine learning purposes.
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-zSCALE(seqs = ptmSeqsVect,outFormat="mat")
ptmSeqsADR<-system.file("extdata/",package="ftrCOOL") ptmSeqsVect<-as.vector(read.csv(paste0(ptmSeqsADR,"/ptmVect101AA.csv"))[,2]) mat<-zSCALE(seqs = ptmSeqsVect,outFormat="mat")