Skip to main content

METHODS article

Front. Genet., 20 November 2019
Sec. Computational Genomics
This article is part of the Research Topic Graph-Based Methods Volume I: Graph-Based Learning and its applications for Biomedical Data Analysis View all 16 articles

Projection-Based Neighborhood Non-Negative Matrix Factorization for lncRNA-Protein Interaction Prediction

Yingjun Ma,Yingjun Ma1,2Tingting He,Tingting He2,3Xingpeng Jiang,*Xingpeng Jiang2,3*
  • 1School of Mathematics & Statistics, Central China Normal University, Wuhan, China
  • 2Hubei Provincial Key Laboratory of Artificial Intelligence and Smart Learning, Central China Normal University, Wuhan, China
  • 3School of Computer, Central China Normal University, Wuhan, China

Many long ncRNAs (lncRNA) make their effort by interacting with the corresponding RNA-binding proteins, and identifying the interactions between lncRNAs and proteins is important to understand the functions of lncRNA. Compared with the time-consuming and laborious experimental methods, more and more computational models are proposed to predict lncRNA-protein interactions. However, few models can effectively utilize the biological network topology of lncRNA (protein) and combine its sequence structure features, and most models cannot effectively predict new proteins (lncRNA) that do not interact with any lncRNA (proteins). In this study, we proposed a projection-based neighborhood non-negative matrix decomposition model (PMKDN) to predict potential lncRNA-protein interactions by integrating multiple biological features of lncRNAs (proteins). First, according to lncRNA (protein) sequences and lncRNA expression profile data, we extracted multiple features of lncRNA (protein). Second, based on protein GO ontology annotation, lncRNA sequences, lncRNA(protein) feature information, and modified lncRNA-protein interaction network, we calculated multiple similarities of lncRNA (protein), and fused them to obtain a more accurate lncRNA(protein) similarity network. Finally, combining the similarity and various feature information of lncRNA (protein), as well as the modified interaction network, we proposed a projection-based neighborhood non-negative matrix decomposition algorithm to predict the potential lncRNA-protein interactions. On two benchmark datasets, PMKDN showed better performance than other state-of-the-art methods for the prediction of new lncRNA-protein interactions, new lncRNAs, and new proteins. Case study further indicates that PMKDN can be used as an effective tool for lncRNA-protein interaction prediction.

Introduction

RNA represents the direct output of genomic encoded genetic information, and a large part of the regulatory capacity of cells focuses on the synthesis, processing, transportation, modification, and translation of RNA. With the continuous improvement of RNA analysis, cell type isolation, and culture technology, people’s understanding of many biological functions of RNA is also getting higher and higher (DjebaliDavis and Merkel et al., 2012). Studies have shown that up to 85% of human genes are transcribed, but the proportion of RNA transcriptional codons encoding proteins is extremely low, suggesting that most RNA transcripts are non-coding (Fang and Fullwood, 2016). A large part of human genes plays their functions through non-coding RNA (ncRNA) (Mattick, 2005). Transcriptional ncRNA has similar chromosome modification functions to protein-coding genes. In multiple sites of human genome, the deletion of ncRNA will lead to the decline of the specificity of adjacent protein-coding genes (Ulf Andersson ørom et al., 2010). Long non-coding RNA (lncRNA) is an important type of ncRNA, which has more than 200 nucleotide transcripts and no obvious protein coding function (Volders et al., 2013). With the development of biological information, people are becoming more and more aware of the important role of lncRNA in various biological processes; lncRNA is involved in the regulation of gene expression and function of multiple networks, affects the formation of the kernel structure domain and whole chromosome state of transcription, and participates in the interaction of two different chromosomal regions through direct mechanisms regulating the chromosome structure (Batista and Chang, 2013). In addition, a growing number of studies have shown that mutations and disorders of lncRNA are associated with different human diseases. The primary structure, secondary structure, expression level of lncRNA, and changes in its homologous binding protein can lead to a variety of diseases ranging from neuropathy to cancer (Wapinski and Chang, 2011). Currently, more and more lncRNA have been discovered, but their functions and mechanisms are still poorly understood. In general, almost all lncRNA functions are expressed through the interaction with the corresponding RNA-binding proteins, and their functions and mechanisms depend on their interaction with various protein complexes in cells (Khalil and Rinn, 2011). Therefore, it is important to determine the potential interactions between lncRNAs and proteins to study the functions of lncRNA. It is expensive and time-consuming to detect large-scale lncRNA-protein interactions by experimental means, so a large number of computational models are proposed based on existing experimental data (Suresh et al., 2015).

Based on the physicochemical properties of peptide chains and nucleotide chains, Bellucci et al. (2011) proposed catRAPID in 2011, which combined secondary structure, hydrogen bonding, and van der Waals to predict the interactions between lncRNAs and proteins. Subsequently, Lu et al. (2013) proposed the lncPro model, which used the secondary structure, hydrogen bonds, van der Waals, and other features to encode nucleotide and amino acid sequences into feature vector, and calculated the interaction scores between lncRNAs and proteins by Fisher’s linear discriminant method. Suresh et al. (2015) proposed the RPI-Pred to predict the interactions between lncRNAs and proteins, which combined the secondary structural feature of RNA sequences with the three-dimensional structural feature of proteins and used support vector machine (SVM) model for prediction. Xiao et al. (2017) proposed a PLPIHS model, which constructed a heterogeneous model by using lncRNA-lncRNA similarity network, lncRNA-protein interaction network, and protein-protein interaction network, and then established a SVM classifier to predict lncRNA-protein interaction by HeteSim score. Subsequently, Deng et al. (2018) improved on PLPIHS and proposed a PLIPCOM model, which simultaneously obtained the low-dimensional features of lncRNA (protein) by restarted random walk and singular value decomposition on heterogeneous networks, and then used the gradient asymptotic tree algorithm to predict by combining the HeteSim score and low-dimensional features. Both algorithms achieved high AUC values, but they used the known lncRNA-protein interaction information to construct heterogeneous network, which also led to the reuse of the known interactions. Recently, Hu et al. (2018) proposed an ensemble strategy to predict potential lncRNA-protein interactions (HLPI-Ensemble), which used the strategy of random pairing to generate negative samples of lncRNA-protein interactions, and integrated support vector machine (SVM), random forest (RF), and extreme gradient enhancement (XGB) three mainstream machine learning algorithms to predict interaction scores. This ensemble learning strategy can not only improve the prediction performance of the model, but can also prevent the over-fitting of the model to some extent. Pan and Shen. (2017) used hybrid convolutional neural network and deep belief network to predict RNA-protein binding sites on RNAs, which used multimodal deep learning to fuse shared features of different sources of data, and found the explainable binding motifs. The above supervised learning method has achieved certain effects in predicting lncRNA-protein interactions, but there are still some problems. First, the key to supervised learning is to construct as balanced as possible positive and negative samples, but at present, most databases only provide lncRNA-protein interaction information, while the construction of negative samples is still a problem. Second, lncRNA-protein interaction prediction problem is a serious unbalanced classification problem, and the known interaction accounts for less than 1% of the total lncRNA-protein pairs, while many supervisory models often choose the same number of positive and negative samples as training set and test set, which artificially reduces the prediction range of the model to some extent. Finally, both lncRNA and protein exist in a whole biological network, and the rational use of lncRNA (protein) network topology can greatly improve the predictive performance of the model.

Recently, many network-based models have been proposed for predicting lncRNA-protein interactions. Li et al. (2015) proposed a heterogeneous network model to predict lncRNA-protein interactions, which constructed a lncRNA similarity network using lncRNA expression profiles and protein similarity network using weighted protein-protein interactions (PPIs), then combined with known lncRNA-protein interaction network uses the restart random walk model to make predictions. Ge et al. (2016) proposed a binary network inference algorithm (LPBNI) using only the known lncRNA-protein interactions to infer potential lncRNA-associated proteins. Zheng et al. (2017) predicted potential lncRNA-protein interactions by fusing multiple network information. Specifically, based on protein sequence, protein domain, protein GO term and STRING dataset, the method constructed four protein similarity networks, respectively, and integrated with similarity network fusion algorithm (SNF), and then used random walk algorithm to calculate the score. Recently, Zhang et al. (2018a) proposed a linear neighborhood propagation algorithm (LPLNP) to predict the potential lncRNA-protein interactions. Specifically, based on various feature extracted, LPLNP calculated the linear neighborhood similarity of the corresponding lncRNA (protein), and used the label propagation algorithm to calculate the interaction scores, and finally the linear combination of all prediction scores as the final result. Subsequently, Zhang et al. (2018b) proposed a sequence-based feature projection ensemble learning algorithm (SFPEL-LPI). Specifically, based on lncRNA sequences, protein sequences, and known lncRNA-protein interactions, SFPEL-LPI extracted a variety of lncRNA (protein) features and similarity information, and uses feature projection ensemble learning framework to predict lncRNA-protein interaction scores. Compared to LPLNP, SFPEL-LPI has fewer parameters and higher precision and can predict new lncRNAs and new proteins. Most network-based models build similarity networks by mining lncRNA (protein) related information and use their network topological structure and known lncRNA-protein interaction information for prediction and have the advantage of not requiring negative sample construction. In addition, this type of method is also global; based on the prediction results, we can get the prediction ranking of all unknown interaction pairs, which is more convenient for us to study the higher-ranking unknown interaction. However, in addition to SFPEL-LPI, other network-based methods only focus on the construction of similarity networks and ignore important feature information. Although SFPEL-LPI makes use of both feature information and similarity information, it separates the lncRNA network and protein network for prediction, which also limits the improvement of model performance.

Based on this, this study proposes a projection-based neighborhood non-negative matrix factorization (PMDKN) to predict potential lncRNA-protein interactions in heterogeneous omics data, which is also applicable to the prediction of new lncRNAs and new proteins. First, based on the lncRNA sequences, lncRNA expression profile, and protein sequences, we extracted a variety of features of lncRNA and protein. Second, based on multiple features of lncRNA and protein, lncRNA sequences, gene ontology annotation of the protein and the modified lncRNA-protein interaction network, we calculated multiple similarities of lncRNA and protein and fused to obtain more accurate lncRNA (protein) similarity network. Finally, PMDKN uses these features and fused similarity network to predict lncRNA-protein interaction scores. The results indicate that PMDKN exhibits higher predictive performance than other state-of-the-art methods for the prediction of lncRNA-protein interactions, new lncRNAs, and new proteins. Case study further demonstrates that PMDKN can be an effective tool for lncRNA-protein interaction.

Materials and Methods

Dataset

The noncoding RNAs and protein related biomacromolecules interaction database (Npinter) (Wu et al., 2006) provides a large number of experimentally verified interactions between non-coding RNA and other biomolecules. So far, Npinter has been updated to version 3.0, which includes more lnRNA-protein interactions than the previous version (Hao et al., 2016). In order to evaluate the predictive performance of the algorithm, we performed cross-experiment using the interactive data provided in Npinter v2.0 (Yuan et al., 2013) as the benchmark dataset and used Npinter v3.0 to test the final prediction ability of the model. Li et al. (2015) extracted interactions from Npinter v2.0 by limiting the organization to ‘Homo sapiens’ and ncRNA to ‘NONCODE’ and processed 4,870 interactions between 1,113 lncRNAs and 96 proteins. On this basis, Zhang et al. (2018a) deleted lncRNAs and proteins with no sequence information and only one interaction, resulting in 4,158 interactions between 990 lncRNAs and 27 proteins. Meanwhile, various features and similarity information were extracted based on the sequence data of lncRNAs and proteins. In order to facilitate the experimental comparison, we used the dataset provided by Zhang et al. (2018a) as the benchmark DATASET 1 for verification.

In benchmark DATASET 1, all lncRNAs (proteins) interact with at least two proteins (lncRNAs), and the number of lncRNA-protein interactions is relatively dense. To investigate the predictive ability of the algorithm for sparse interactions, lncRNAs without sequence information were deleted from the data provided by Li et al., and a total of 4,679 interactions between 1,068 lncRNAs and 90 proteins were finally obtained. Meanwhile, sequence information of lncRNA and expression profile information of lncRNA in 24 human tissues and cells were extracted from the integrated knowledge database of non-coding RNAs database (NONCODE) (Liu, 2004; Xie et al., 2013; Fang et al., 2018), and sequence information of protein and gene ontology annotation of protein were extracted from the protein-protein interaction networks dataset (STRING 9.1) (Franceschini et al., 2012). Based on the relevant information of lncRNA and proteins, multiple features and similarities of lncRNA (proteins) were calculated to construct benchmark DATASET 2.

Features for lncRNAs and Proteins

Let ={l1,l2,,lNl} and ={p1,p2,,pNp} represent the set of Nl lncRNAs and Np proteins obtained, respectively. In this section, we introduce the three features of lncRNA, the two features of the protein, and the similarity of lncRNA and the similarity of protein.

Features of lncRNA

We extracted three features of lncRNA, namely expression profile feature and two sequence-based features: pseudo-k-tuple nucleotide composition (PseKNC) (Chen et al., 2014) and parallel related pseudo dinucleotide composition (PCPseDNC) (Guo et al., 2014). For lncRNA, k-mer (nucleotide sequence of length k) is generally used to describe the short-term ordered information of the sequences, while the overall or long-term information of the sequences is described by the physicochemical properties of nucleotides. PseKNC and PCPseDNC describe the lncRNA by integrating the short-term and long-term features of the sequences (Chen et al., 2014). We calculated the PseKNC and PCPseDNC of lncRNA using python “repDNA” package (Liu et al., 2015).

Features of Protein

The hydrophilicity and hydrophobicity of proteins play an important role in protein folding, environmental and molecular interactions, and catalytic effects. Combining the frequency of regularization of 20 amino acids in the protein sequence and the distribution pattern of hydrophilicity and hydrophobicity along the protein chain, we calculated the characteristics of the two proteins, which are the amphiphilic pseudo amino acid composition (APseAAC) (Chou, 2001; Chou, 2005) and the combined triad descriptor (CTriad). Among them, Ctriad was proposed by Shen et al. (2007) to predict protein-protein interactions. First, in order to reduce the size of the feature space, 20 amino acids were grouped into 7 classes according to the dipole and volume of the side chains. Second, using the classes of amino acids to distinguish any conjoint triad (combination of any three consecutive amino acids) and counting the frequency. f(vi)i=1,2,.···,73 of the occurrence of the conjoint triad in the amino acid sequence, where vi represents the i-th conjoint triad. Finally, normalizing f(vi), we could get the conjoint triplet descriptor feature CTriad(P)=[q1,q2,···,q343] of protein P as follows:

qi=f(vi)-min{f(vi)}i=1343max{f(vi)}i=1343-min{f(vi)}i=1343

Where, min{f(vi)}i=1343 and max{f(vi)}i=1343 represent the minimum and maximum frequencies of all conjoint triads, respectively. It should be noted that in order to prevent the over-fitting problem caused by the lncRNA (protein) feature due to the high dimension, we use the PCA for dimensionality reduction on the high-dimensional features.

Similarities for LncRNAs and Proteins

In this section, we introduce the lncRNA-lncRNA similarity and the protein-protein similarity.

lncRNA-lncRNA Sequence Similarity

Kirk et al. (2018) found that lncRNAs with related functions, although lacking linear homology, often have a similar k-tuple spectrum, which is related to lncRNA binding protein and its subcellular localization. Song et al. (2014) introduced a variety of alignment-free genome and metagenome comparison methods based on word frequency and proved that d2* has a stronger statistical ability to measure sequence correlation. Therefore, d2* was used in this study to calculate the sequence similarity between lncRNAs. For any two lncRNA sequences L1 and L2 with m and n nucleotides, respectively, the dissimilarity d2*(L1,L2) is as follows:

d2*(L1,L2)=12(1D2*(L1,L2)wAkX˘w2/(m¯pwX)wAkY˘w2/(n¯pwY))

Where D2*(L1,L2) represents the D2* statistic of L1 and L2, and pwX and pwY respectively represent the probability of k-tuple w occurring in L1 and L2 of lncRNA under the background model. m¯=mk , n¯=nk , X˘w=Xwm¯pwX , Y˘w=Ywn¯pwY , where Xw and Yw represent the frequencies at which the k-tuples in the sequences L1 and L2 occur, respectively. Further, the similarity of L1 and L2 is (1d2*(L1,L2)) . We used the program provided by Ahlgren et al. (2016) to calculate the d2* similarity of lncRNA.

Protein-Protein Semantic Similarity

The semantic comparison of gene ontology annotations provides a quantitative method for calculating the semantic similarity of gene products (Yu et al., 2010). There are currently two classic methods for computing the semantic similarity of GO annotation items: information-based methods (Jiang and Conrath, 1997; Lin, 1998; Resnik, 1999) and graph-based (Wang et al., 2007) methods, respectively. In this study, the graph-based method was first used to calculate the semantic similarity of GO items, and then the semantic similarity of proteins was calculated according to the association between protein and GO items. Specifically, any GO item A could be expressed as DAG(A)=(A,TA,EA), where TA represents the set containing item A and all its ancestor items in the GO diagram, and EA represents the set connecting all edges of GO item in DAG(A). Then, for any two GO annotation items A and B, their semantic similarity could be defined as:

S(A,B)=tTATBSA(t)+SB(t)SV(A)+SV(B)

Where, SA(t) and SB(t) represent the S-value of GO item t related to item A and item B respectively, and SV(A)=tTASA(t) represents the semantic value of GO item A. At this point, according to the correlation between protein and GO term, we can get the semantic similarity of protein. We use R package “protr” to obtain semantic similarity of proteins; more details are shown in (Xiao et al., 2015).

Kernel Neighborhood Similarity

In Section “Features for lncRNAs and Proteins”, we obtained three features of lncRNA and two features of protein, and the known lncRNA-protein interaction network also contains important lncRNA (protein) feature information. Based on these feature vectors, there are many methods for calculating similarities, such as Gaussian, linear neighborhood similarity (Zhang et al., 2018a) (LNS), and so on. Here, we adopt kernel neighborhood similarity (KSNS) (Ma et al., 2018a; Ma et al., 2018b), which not only considers the neighbor and non-neighbor similarity of samples hierarchically, but also explores nonlinear relations, which was well applied to a variety of biological problems. It should be noted that the currently known lncRNA-protein interaction matrix is incomplete. Therefore, in order to reduce the error caused by information loss, we first use the Weighted K nearest neighbor profiles (WKNNP) (Xiao et al., 2018) to complete the known interaction matrix, and then calculated the KSNS of lncRNA(protein) interaction profile.

Based on the above steps, we obtained a total of 5 similarities of lncRNAs and 4 similarities of proteins, which reflected the similarity relationship of lncRNAs (proteins) from different perspectives. Due to the limitations of data and the selection of computational methods, these similarity networks may contain noise. Hence, we adopted a clusDCA proposed by Wang et al. (2015) for similarity network fusion, which can not only eliminate network noise and effectively capture network topology, but also have high computational efficiency in large-scale networks. The general procedure for predicting lncRNA-protein interaction using PMDKN is shown in Figure 1.

FIGURE 1
www.frontiersin.org

Figure 1 Flow chart of lncRNA-protein interaction prediction by PMDKN algorithm. As shown in the figure, we first calculated three features of lncRNAs and two features of proteins, and then calculated five similarities of lncRNAs and four similarities of proteins according to lncRNA sequence, protein GO annotation and their features.

Prediction of lncRNA-Protein Interaction

Based on various features of lncRNA (protein) and the integrated lncRNA (protein) similarity network, we proposed projection-based neighborhood non-negative matrix factorization (PMDKN) to predict potential lncRNA-protein interactions. {FLi}i=1N1 represents the N1 feature matrices of lncRNA, {FPi}i=1N2 represents the N2 feature matrices of protein, similarity matrix of lncRNA and protein are SL and SP respectively, A represents known lncRNA-protein interaction matrix, and A¯ represents lncRNA-protein interaction matrix completed by WKNNP.

First, we mapped lncRNA and protein to the common non-negative space Rd, that is, any lncRNA li and protein pj can be represented by non-negative latent vectors uiRd×1 and vjRd×1 . For simplicity, we further denote the latent vectors of all lncRNAs and all proteins by U=(u1,,uNl)TRNl×d and V=(v1,,vNh)Rd×Np , then, the product of the U and V can be used to approximate the modified interaction matrix Ā. Since the observed interactions have been verified by experiments and have higher reliability than the unknown interactions, the observed lncRNA-protein interactions are assigned a higher level of importance and can be obtained as follows:

minU,V{12||C(A¯UVT)||F2+γ2(||U||F2+||V||F2)}
s.t.   U0, V0(1)

where C is the importance level distribution matrix, that is, if there is interaction between the lncRNA li and the protein pj, Ci,j= δ, otherwise, Ci,j = 1, where δ > 1 is an important level parameter. ||·||F denotes the F-norm and γ denotes the regularization parameter of latent vectors.

In addition, in order to integrate different types of lncRNA features, we project all lncRNA features onto the non-negative space Rd, and required the difference between it and U to be as small as possible, so as to obtain:

min PLi{i=1N1αiη||FLiPLiTU||F2+μ2i=1N1k=1r||PLi(k,:)||12}
s.t. PLi0(2)

where FLiRNl×dli represents the i-th feature matrix of lncRNA, dli represents the dimension of the feature, and PLiRr×dli represents the corresponding projection matrix. In order to facilitate calculation and convenient interpretation, PLi is required to be non-negative. The Weight vector α=(α1,α2,,αN1) controls the effect of different feature projections on U. The projection index parameter η > 1 is the index of α, indicating that all features contribute to the generation of U. µ is the regularization parameter of projection matrix, and P(k,:) is the k-th row of the matrix P. ||PLi(k,:)|| represents the 1 -norm of the vector PLi(k,:) (ie, ||P(k,:)||1=j|P(k,j)| ), ensuring that the projection vector PLi(k,:) is as sparse as possible, and k=1r||PLi(k,:)||12 is equivalent to the square of the 1,2 -norm of the matrix PLi. Therefore, equation (2) can be expressed as follows:

min PLi{i=1N1αiη||FLiPLiTU||F2+μ2i=1N1||PLi||1,22}
s.t. PLi0(3)

Similarly, for proteins, we have:

min PPj{j=1N2βjη||FPjPPjTV||F2+μ2j=1N2||PPj||1,22}
s.t. PPj0(4)

where FPjRNp×dpj represents the j-th feature matrix of the protein, and non-negative matrix PPjRr×dpi represents the corresponding projection matrix. The weight vector β=(β1,β2,,βN2) controls the effect of feature projection on V.

It is generally believed that lncRNAs with higher similarity are more likely to interact with the same protein, but due to the incomplete data set, the similarity network of lncRNAs (proteins) obtained may contain noise. In order to eliminate the influence of non-neighborhood noise and improve the prediction accuracy, we only consider strong neighborhood similarity relationship of the samples. Therefore, lncRNA neighborhood similarity matrix (SL¯ ) was constructed as follows:

SL¯i,j={SLi,j           if ljN(li) or liN(lj)0             otherwise                       (5)

Among them, SL¯i,j represents the local similarity of lncRNA li and lj, and N(li) represents the K neighbor sets closest to lncRNA li. In order to adaptively select the number of neighbors according to the sample size, we make K=0.3×Nl ,   indicates rounding up. It is known from equation (5) that  SL¯ is a symmetric matrix. According to lncRNAs with higher similarity, their features are as close as possible; we have:

λ2ijSL¯i,j||uiuj||F2=λtr(UT(DlSL¯)U)=λtr(UTLPlU)(6)

Where tr() represents the trace of the matrix, λ is the neighborhood Laplacian regularization parameter, and LPl=DLSL¯ is the Laplacian matrix of the lncRNA. The diagonal matrix Dl=diag(dL1,dL2,,dLNl) , whose diagonal elements are dLi=kSL¯i,k , respectively. Similarly, we can calculate the neighborhood similarity matrix SP¯ of the protein as follows:

SP¯i,j={SPi,j   if pjN(pi) or piN(pj)0             otherwise(7)

Furthermore, the objective function can be obtained as follows:

λ2ijSP¯i,jpipjF2=λtr(VT(DpSP¯)V)=λtr(VTLPpV)(8)

where LPp=DpSP¯ is the Laplacian matrix of the protein. The diagonal matrix Dp=diag(dP1,dP2,,dPNp) , whose diagonal elements are dPi=kSP¯i,k , respectively. Combined with the above formulas, the objective function of PMKDN algorithm can be obtained as follows:

minU,V,GUi,GVj,αi,βj{12||C(A¯UVT)||F2=12i=1N1αiη||FLiPLiTU||F2+12j=1N2βjη||FPjPPjTV||F2+λ2(tr(UTLPlU)+tr(VTLPpV))+μ2(i=1N1||PLi||1,22+j=1N2||PPj||1,22)+γ2(||U||F2+||V||F2)}
st.   U0, V0,  PLi0, PPj0,i=1N1αi=1,j=1N2βj=1, αi0, βj0(9)

We use the two-step method to solve (9). First, by fixing αi, βj, and using the Lagrangin multiplier and the KKT condition, we can get the iterative formula of U, V, PLi and PPj as follows:

U =U(CA¯)V+i=1N1αiηFLiPLiT+λ1SL¯U(CUVT)V+i=1N1αiηU+λ1Dl U+γ1U(10)
V=V(CA¯T)U+i=1N1βjηFPjPPjT+λ2SP¯V(CVUT)U+j=1N2βjηV+λ2DpV+γ2V(11)
PLi=PLiαiηUTFLiαiηPLiFLiTFLi+μ1PLieeT(12)
PPj=PPjβjηVTFPjβjηPPjFPjTFPj+μ2PPjeeT(13)

Then, fix U, V, PLi and PPj, and let ai=||FLiPLiTU||F20 , bj=||FPjPPjTV||F20 , C1 represents the terms unrelated to αi and βj (3.8). We can get the objective function about αi and βj as follows:

minα,β{12i=1Nuaiαiη+12j=1Nvbjβη+C1}
i=1Nuαi=1,j=1Nvβj=1,αi0, βj0

Using the Lagrangian multiplier, the iterative formula for αi and βj can be obtained as follows:

αi=(1ai)1η1i=1N1(1ai)1η1=(1||FLiPLiTU||F2)1η1i=1N1(1||FLiPLiTU||F2)1η1(14)
βj=(1bj)1η1j=1N2(1bj)1η1=(1FPjPPjTVF2)1η1j=1N2(1FPjPPjTVF2)1η1(15)

According to (14) and (15), αi and βj always satisfy non-negative constraints. In formula (9), U and V are obtained based on the decomposition of the known lncRNA-protein interaction matrix. In order to reduce the prediction error of the new lncRNA (lncRNA without any protein interaction information) and the new protein, we utilized the method proposed by Liu et al. (2016), that is, the lncRNA(protein) was modified by using the neighborhoodlatent vectors. Let ũi the modified latent vector of lncRNA li, which can be calculated as follows:

u˜i={                  ui                                if    j=1NpAi,j>01QLisN+(li)SL(i,s)us           otherwise               (16)

where, the first item j=1NpAi,j>0 indicates that the latent vector of lnRNA with protein interaction remain unchanged. The second term refers to the modification of latent vector of lncRNAs without protein interaction, where N+(li) refers to the set composed of K lncRNAs with the highest similarity to li among lncRNA sets with protein interaction. In order to make the number of neighbors automatically adapt to the size of samples, we set K=max(5,0.1×Nl) , where Qi=sN+(di)SL(i,s) represents the normalized term. Similarly, we modified the latent vector of proteins as follows:

v˜j={            vj                                   if    i=1NlAi,j>01QPjtN+(lj)SP(j,t)vt       otherwise             (17)

By using the modified latent vector U˜=[u˜1,u˜2,,u˜Nl] of lncRNA and the modified latent vector V˜=[v˜1,v˜2,,v˜Np] of protein, we can obtain the final lncRNA-protein interaction score Y¯=U˜V˜T.

Algorithm

In the process of model derivation, we assume that the features of lncRNA and protein are non-negative, so the original features need to be normalized before algorithm calculation. Let F^RN×M represent the original feature matrix of lncRNA (protein), where F^i,j represents the j-th dimension of the i-th sample, then the normalized feature matrix F is as follows:

Fi,j=F^i,jmin(F^.j)max(F^.j)min(F^.j)(18)

Where, min (F.j) and max (F.j) represent the minimum and maximum of the j-th dimension, respectively. Algorithm 1 summarizes the general process of solving lncRNA-protein interaction prediction by KDMPN.

Algorithm 1. KDMPN.
Input: Known lncRNA-protein interaction matrix A; Modified lncRNA-protein interaction matrix Ā; Importance level parameter δ; LncRNA original feature matrix {FLl^}i=1N1; Protein initial feature matrix {FPj^}j=1N2; LncRNA similarity matrix SL; Protein similarity matrix SP; Potential subspace regularization parameter r; Projection index parameter η>1; Projection matrix regularization parameter µ; Neighborhood Laplacian regularization parameter λ; Potential subspace regularization parameter γ.

Output: LncRNA latent vector Ũ; Protein latent vector V˜; Predictive interaction matrix Y¯; LncRNA feature projection matrix {PLi}i=1N1; Protein feature projection matrix {PPj}j=1N2; LncRNA projection parameter {αi}i=1N1; Protein projection parameter {βj}j=1N2.

Initialize:

1 The importance level distribution matrix (C)Nl×Np is calculated from δ and A, andthe normalized lncRNA feature matrix {FLi}i=1N1 and the protein projection matrix {FPj}j=1N2 are obtained by using Equation (18) for {FLi^}i=1N1 and {FPl^}i=1N2. Based on SL and SP, the neighborhood similarity matrices SL¯ and SP¯ of lncRNA and protein were obtained using equations (5) and (7), respectively. Initialize U,V||  {PLi}i=1N1 and {PPj}j=1N2 using the random number of the [0, 1] interval.

2 for i1,2,,N1 do

Fix PLi and U, calculate αi according to formula (14).

end for

for i1,2,,N2 do

Fix PPj and V, calculate βj according to formula (15).

end for

repeat

3 Fix {αi}i=1N1 and {PLi}i=1N1, Update U according to formula (10).

4 Fix {βj}j=1N2 and {PPj}j=1N2, Update V according to formula (11).

5 for i1,2,,N1 do

Fix {αi}i=1N1 and U, Update PLi according to formula (12).

Fix PLi and U, Update αi according to formula (14).

end for

6 for j1,2,,N2 do

Fix {βj}j=1N2 and V, Update PPj according to formula (13).

Fix PPj and V, Update βj according to formula (15).

end for

until Converges

7 Ũ was obtained by completing the subspace feature U of lncRNA according to formula (16).

8 V˜ was obtained by completing the subspace feature V of protein according to formula (17).

9 Y¯=U˜V˜T

Results and Discussion

Experimental Settings

According to previous studies, the performance of the interactive prediction method was evaluated by the 5-fold cross validation (CV), and the area under ROC curve (AUC), area under Precision-Recall curve (AUPR), and F1 value (F1) were used as evaluation indexes. Since the known lncRNA-protein interactions were much less than the unknown lncRNA-protein interactions, AUPR was usually used as the most important evaluation index to punish false positives (Zhang et al., 2018a; Zhang et al., 2018b).

In addition, in order to eliminate the influence of random partition on the results in the crossover experiment, we selected the method ofLiu et al. (2016), set 5 random seeds for CV, and took the mean value of the cross experiment results under all random seeds as the final prediction result. Specifically, the lncRNA-protein interaction matrix ARNl×Np has Nl rows for lncRNAs and Np columns for proteins. In order to investigate the prediction ability for lncRNA-protein interactions, new lncRNAs and new proteins, we performed CV under three different settings, as follows:

1. CVa: CV on known lncRNA-protein interaction pairs. Specifically, we randomly divided the known lncRNA-protein interactions into 5 equal parts. Take turns to select one and all the unknown interactions to form the test set and the remaining four and all the unknown interactions to form the training set (that is, change the 1 corresponding to the test set in A into 0 as the training set).

2. CVl: CV on lncRNAs. Specifically, all lncRNAs are randomly divided into five equal parts; one is selected as a test set in turn, and the remaining four are training sets (that is, all the rows corresponding to the test set in A were changed to zeros).

3. CVp: CV on proteins. Specifically, all proteins are randomly divided into five equal parts; one is selected as a test set in turn, and the remaining four are training sets (that is, all the columns corresponding to the test set in A were changed to zeros).

It should be noted that with regard to CVa, we selected all zeros in A as the test set. For example, for DATA2, the test set of each crossover experiment contains 4,870/5 = 947 known interactions and 97,658 unknown interactions (that is, the ratio of positive and negative examples is approximately 1:100). This selection method ensures that all the unknown interactions can be included in each crossover experiment, which expands the search range and is also in line with the actual situation.

Parameter Setting

The PMDKN algorithm have six parameters, namely the projection index parameter η, the projection regularization parameter µ, the latent vector regularization parameter γ, the neighborhood Laplacian regularization parameter λ, the potential subspace dimension d, and the known interaction important level parameter δ. Among them, µ and γ control the influence of feature projection, γ controls subspace feature contribution, λ describes the effect of similarity network, and δ controls the importance level of observed interaction. In order to study the effect of parameters on the prediction results, we calculated all the parameter combinations. Specifically, η was selected from {2,3,4,5,6}, µ was selected from {10-3,10-2,10-1,100,101}, γ was selected from {10-3,10-2,10-1,100,101}, and λ was selected from {2-2,2-1,2021,22,23}; according to the previous research (Zheng et al., 2013, Liu et al., 2016, Xiao et al., 2018), for methods based on matrix decomposition, the potential subspace dimension d = 100, δ was selected from {1,2,⋯, 6}.

It should be noted that unlike DATASET 1, DATASET 2 contained more lncRNAs and proteins, and the initially constructed lncRNA (protein) similarity network did not utilize any known interaction information and therefore has higher predictive value. In addition, since CVa, CVl, and CVp are considered the predictive power of the algorithm for new interactions, new lncRNAs, and new proteins, respectively, we believe that the three experimental setups are equally important for algorithm evaluation. Therefore, based on DATASET 2, for the combination of different parameters, the average evaluation index of the algorithm under the three experimental settings is the final evaluation standard. We take AUPR as the evaluation index, and the influence of the analysis parameters on the prediction results was shown in Figure 2.

FIGURE 2
www.frontiersin.org

Figure 2 The influence of parameters on the AUPR value of PMDKN. Among them, (A) represents the influence of the projection parameters µ and η on the AUPR value. (B) shows the effect of the neighborhood Laplacian regularization parameter λ. (C) shows the effect of the feature regularization parameter γ. (D) indicates the effect of observing the important level parameter δ.

As shown in Figure 2, the optimal parameters obtained by the PMDKN algorithm are η = 5, µ = 100, λ = 1, γ = 1, δ = 2, and the average optimal AUPR value under the three experimental settings is 0.4735. Specifically, we first analyze the influence of the projection parameters η and µ. Fixed λ = 1, γ = 1, δ = 2, and calculate the AUPR value of the model under all possible combinations of η and µ. As shown in (A) of Figure 2, as η becomes larger, the AUPR value of the model increases, but the overall AUPR value of the model fluctuates a little. Then, we fixed η = 5, µ = 100, γ = 1, δ = 2, and analyzed the influence of the change of λ on the AUPR value. As shown in (B) of Figure 2, when λ increases, the AUPR value of the model first becomes larger and then decreases, and when λ = 1, the AUPR value is the largest. Similarly, as shown in (C) in Figure 2, when γ < 1, the change of AUPR was relatively flat; when γ > 1, the AUPR value decreased sharply with the increase of gamma. In (D), δ = 1 indicates that the known interactions and the unknown interactions are equally important, and the corresponding AUPR value of the model is only 0.42; however, when δ = 2, the model has the maximum AUPR value, which further emphasized that the setting of δ is necessary to improve the performance of the model.

Based on the above discussion, in the following study, we select η = 5, µ = 100, λ = 1, γ = 1, d = 100, and δ = 2 as parameters of PMDKN.

Comparison With State-of-the-Art Prediction Methods

In order to evaluate the predictive ability of PMDKN algorithm equitably, we conducted 5-fold cross validation on DATASET 1 and DATASET 2, and compared them with the following methods: SFPEL-LPI (Zhang et al., 2018b), LPLNP (Zhang et al., 2018a), LPBNI (Ge et al., 2016), and LKSNF (Ma et al., 2018b). Since DATASET 1 itself was the benchmark dataset for SFPEL-LPI, LPLNP, and LKSNF, we do not need to re-extract the features. For DATASET 2, we calculated the PCPseDNC and SCPseAAC of lncRNA according to the requirements of SFPEL-LPI, and calculated the PCPseAAC and SCPseAAC of the protein. Since SWSS similarity leads to the reuse of known interaction information, only the Smith Waterman similarity of lncRNA (protein) were calculated. For LPLNP and LKSNF, we calculated the sequence feature and expression profile feature of lncRNA and the CTD of the protein according to their requirements. While LPBNI only uses known lncRNA-protein interactions for prediction, we did not need to extract additional information. According to previous studies, LPLNP, LPBNI, and LKSNF only predicted the unknown interaction of lncRNA-protein, while SFPEL-LPI not only predicted unknown lncRNA-protein interactions, but also predicted new lncRNA and new protein. Therefore, based on DATASET 1 and DATASET 2, we perform CVa on all models, and CVl and CVp on SFPEL-LPI. We performed the crossover experiment using the experimental setup in Section “Experimental Settings” and used the mean of the five-fold crossover experimental results of the five random seeds as the evaluation index of the algorithm, and the parameters of these models were selected using the recommended parameters.

Table 1 shows the comparison of predictive performance of PMDKN and other state-of-the-art methods for new lncRNA-protein interaction prediction. It can be seen that, no matter in DATASET 1 or DATASET 2, the AUPR, AUC, and F1 values of PMDKN are higher than other models. Specifically, on DATASET 1, as for the most important evaluation index AUPR, PMDKN can reach 0.4959, which increases by 50.46%, 8.37%, 4.31%, and 6.07%, respectively, compared with LPBNI’s 0.3296, LPLNP’s 0.4576, LKSNF’s 0.4754, and SFPEL-LPI’s 0.4675. Regarding the commonly used evaluation index AUC, PMDKN can reach 0.9223, which is higher than 0.8546 of LPBNI, 0.9095 of LPLNP, 0.9150 of LKSNF, and 0.9201 of SFPEL-LPI. The F1 value of PMDKN can reach 0.4814, which is 24.04%, 6.50%, 4% and 3.37%, respectively, compared with 0.3881 for LPBNI, 0.4520 for LPLNP, 0.4629 for LKSNF, and 0.4657 for SFPEL-LPI. In DATASET 2, the AUPR of PMDKN could reach 0.4808, which improved by 40.67%, 2.45%, 6.18%, and 14.07%, respectively, compared with 0.3418 of LPBNI, 0.4693 of LPLNP, 0.4528 of LKSNF, and 0.4215 of SFPEL-LPI. The AUC value of PMDKN can reach 0.9732, higher than 0.9340 of LPBNI, 0.9700 of LPLNP, 0.9710 of LKSNF, and 0.9728 of SFPEL-LPI. The F1 value of PMDKN can reach 0.4761, which is 19.71%, 3.37%, 2.67%, and 7.04%, respectively, compared with 0.3977 for LPBNI, 0.4606 for LPLNP, 0.4637 for LKSNF, and 0.4448 for SFPEL-LPI. These demonstrate that the PMDKN algorithm of this paper has good predictive power for unknown lncRNA-protein interactions.

TABLE 1
www.frontiersin.org

Table 1 Comparison of predicted performance of new lncRNA-protein interactions based on DATASET1 and DATASET2.

The prediction of new lncRNAs and new proteins are also the important criterion for evaluating the performance of the method. Among the four comparison algorithms above, only SFPEL-LPI performs the prediction of new lncRNA and new protein. Therefore, we only compare the prediction performance of SFPEL-LPI and PMDKN on CVl and CVp. As shown in Table 2, except for the F1 value of PMDKN on DATASET 2, which is 0.4864, slightly lower than the 0.4892 of SFPEL-LPI, PMDKN was better than SFPEL-LPI for other evaluation indicators, especially for the prediction of new proteins (CVp). Specifically, on DATASET 1, the AUPR values of PMDKN for CVl and CVp can reach 0.6301 and 0.4918, which is 30.92% and 49.71%, respectively, relative to SFPEL-LPI of 0.4813 and 0.3285. The AUC values of the PMDKN algorithm for CVl and CVp can reach 0.8907 and 0.7843, which are 7.52% and 17.66% higher than the 0.8284 and 0.6666 of SFPEL-LPI, respectively. The F1 value of the PMDKN algorithm for CVl and CVp can reach 0.6081 and 0.5251, which is 23.32% and 38.95% higher than the 0.4931 and 0.3779 of SFPEL-LPI, respectively. Similarly, in DATASET 2, the AUPR value and AUC value of CVl of PMDKN were higher than SFPEL-LPI, especially for CVp, the AUPR value, AUC value, and F1 value of PMDKN could reach 0.4604, 0.9019, and 0.4818, respectively, improving 281.13%, 37.78%, and 148.35% compared with the 0.1208, 0.6546, and 0.1940 of SFPEL-LPI.

TABLE 2
www.frontiersin.org

Table 2 Comparison of predicted performance of new lncRNAs and new proteins based on DATASET1 and DATASET2.

Comparative Analysis of Model Stability

Due to technical limitations, some noises may be hidden in the known lncRNA-protein interactions, such as lack of interaction information, unreal interaction information and so on. In order to test the dependence of the prediction performance of the model on the known interactions, according to the method of Zhang et al. (2018b), we randomly deleted some of the known interactions to represent the missing information and randomly added the nonexistent interactions to represent the false interactions, and then studied the change of prediction performance of the model. Since only a few interactions have been detected at present, it indicates that there are still a large number of interactions that have not been discovered. Therefore, we deleted 20% of the known lncRNA-protein interactions and added 5% of the interactions that actually do not exist as noise. At this point, the test set of the model becomes 20% known interactions and all unknown interactions. As shown in Figure 3, on the disturbance dataset of DATASET 1, the AUC values of LPBNI, LKSNF, LPLNP, SFPEL-LPI, and PMDKN are 0.8417, 0.8980, 0.8856, 0.9077, and 0.9116, respectively, and the AUPR values are 0.2776, 0.2564, 0.2431, 0.2596, and 0.3392. On the perturbed data set of DATASET 2, the AUC values of LPBNI, LKSNF, LPLNP, SFPEL-LPI, and PMDKN were 0.9297, 0.9707, 0.9646, 0.9687, and 0.9714, respectively, and the AUPR values were 0.2969, 0.2662, 0.2526, 0.2415, and 0.4081, respectively. Comparing the results of Table 1, it can be seen that the introduction of partial noise in the perturbed dataset leads to a decrease in the AUPR and AUC values of all prediction models, but PMDKN still achieves satisfactory results and outperforms LPBNI, LKSNF, LPLNP, and SFPEL-LPI.

FIGURE 3
www.frontiersin.org

Figure 3 Prediction performance of the model on disturbed data set. Among them, (A) shows the ROC curve and AUC value of the five methods after DATASET1 adds noise. (B) shows the P-R curve and AUPR values of the five methods after DATASET1 is added with noise. (C) shows the ROC curve and AUC value of the five methods after DATASET2 adds noise. (D) indicates the P-R curve and AUPR value of the five methods after DATASET2 is added with noise.

Case Study

LncRNA-protein interactions in DATASET 1 and DATASET 2 used in this paper were extracted from Npinter2.0, and the current version of Npinter has been updated to Npinter v3.0 (Hao et al., 2016). Compared with version 2.0(Yuan et al., 2013), Npinter v3.0 contains more lncRNAs, more proteins, and more interactive information. To test the predictive ability of new proteins, we extracted 95 new proteins that did not exist in DATASET 2 from Npinter v3.0, extracted the amino acid sequence and gene ontology annotation of these new proteins, and combined with DATASET2 information to predict the interactions between these new proteins and lncRNAs. For the prediction score of each new protein, we calculated its AUPR and AUC values, and calculated the hit rate of the top 10, 20, 50, and 100 candidate lncRNAs (Nourania et al., 2016). For the new protein pi, the hit rate hit(pi) can be expressed as follows:

hit(pi)=||Cand(pi)Test(pi)|||Test(pi)||

Among them, Cand (pi) represents the candidate lncRNA set of protein pi, and in this paper Cand (pi) represents the top-10, top-20, top-50, top-100 candidate lncRNAs sorted according to the predicted score, respectively. Test (pi) represents the set of lncRNAs for all interactions of protein pi in Npinter v3.0. || indicates the number of elements. As SFPEL-LPI can predict new proteins and new lncRNAs, the predicted results of SFPEL-LPI and PMDKN were compared. The predicted scores, actual labels and evaluation indicators of 95 new proteins are shown in Supplementary Table 1. The average AUPR value, the average AUC value, the average hit rate of the top-10, top-20, top-50, and top-100 predicted by SFPEL-LPI and PMDKN for 95 proteins are shown in Figure 4.

FIGURE 4
www.frontiersin.org

Figure 4 Comparison of SFPEL-LPI and PMDKN prediction results for new proteins. The AUPR and AUC values in the figure represent the average AUPR and average AUC values predicted by PMDKN for 79 proteins, respectively. Top-10 hitrate, Top-20 hitrate, Top-50 hitrate, and Top-100 hitrate represent the mean hit rates of the first 10, 20, 50, and 100 candidate lncRNAs, respectively.

As shown in Figure 4, for the prediction of new proteins, PDMKN not only has higher AUPR and AUC values than SFPEL-LPI, but also the top 10, 20, 50, 100 hit ratios of candidate lncRNAs are much higher than SFPEL-LPI. Specifically, the average AUPR and AUC values for PMDKN were 0.204 and 0.839, respectively, which were 20.66% and 8.49% higher than 0.169 and 0.773 for SFPEL-LPI, respectively. The hit rates of candidate lncRNAs in the top-10, top-20, top-50 and top-100 reached 42.8%, 47.1%, 52.1%, 57.2%, and increased by 266.32%, 264.37%, 125.75%, and 80.68%, respectively, compared with the 11.7%, 12.9%, 23.1%, and 31.7% of SFPEL-LPI, which further demonstrated that PMDKN had strong predictive ability.

Discussion

In this study, we proposed a new lncRNA-protein interaction prediction model, which not only can predict the unknown interactions between lncRNAs and proteins, but also has strong prediction ability for new lncRNAs and new proteins. To fairly evaluate the predictive performance of the model, we performed three 5-fold cross-validation on the two benchmark datasets, namely, CVa for the new lncRNA-protein interactions, CVi for the new lncRNAs, and CVp for the new proteins. The results show that, on DATASET 1, the AUPR values of PMDKN under the three experimental settings could reach 0.4959 (on CVa), 0.6301 (on CVl), and 0.4918(on CVp) respectively; on DATASET 2, the AUPR values of PMDKN under the three experimental settings can reach 0.4808 (on CVa), 0.4794 (on CVl), and 0.4604 (on CVp) respectively, higher than other state-of-the-art methods. In the case study, 95 new proteins were predicted, and the results showed that for the top-10 candidate lncRNAs, the hit rate of PMDKN algorithm could reach 42.8%, much higher than other method. Therefore, PMDKN can be used as an effective tool for lncRNA-protein interaction prediction.

The good performance of PMDKN may have the following reasons: First, feature extraction and network construction. We extract multiple features to describe lncRNA and protein in all directions and integrate multiple infomation to construct a more accurate lncRNA (protein) similarity network, effectively avoiding the over-fitting problem that may be caused by the information deviation of a single data source. Second, the use of neighborhood information. We modified the initial lncRNA-protein interaction network to overcome the network sparsity problem, and used the adaptive neighborhood completion strategy to eliminate the errors caused by the lack of information in the latent vectors of new lncRNAs (new protein), so as to ensure the predictive ability of new proteins and new lncRNAs. Finally, the construction of the ensemble predictive model. We combine the multiple sequence features of lncRNA (protein) and the integrated similarity networks to construct the predictive model, which distinguishes positive and negative observations by setting important levels and establishes the relationship between features and potential vectors through the projection of the features, so as to improve the accuracy of model prediction.

Data Availability Statement

The source code and datasets used in the paper can be found in the Supplementary Files.

Author Contributions

YM and XJ designed the projection-based neighborhood non-negative matrix factorization for lncRNA-protein interaction prediction. YM and XJ designed the experiment and wrote the manuscript. TH and XJ supervised and helped conceive the study. All authors read and approved the final manuscript.

Funding

This research is supported by National Key Research and Development Program of China (2017YFC0909502) and the National Natural Science Foundation of China (61532008 and 61872157).

Conflict of Interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

Acknowledgments

The authors would like to thank the anonymous reviewers for their valuable comments and suggestions to improve the quality of this paper.

Supplementary Material

The Supplementary Material for this article can be found online at: https://www.frontiersin.org/articles/10.3389/fgene.2019.01148/full#supplementary-material

S1 Table | Prediction results of 95 new proteins by SFPEL-LPI and PMDKN.

S1 File | Eps format for all pictures in the manuscript.

S2 File | The code and data of PMDKN.

References

Ahlgren, N. A., Ren, J., Lu, Y. Y., Fuhrman, J. A., Sun, F. (2016). Alignment-free d * 2 oligonucleotide frequency dissimilarity measure improves prediction of hosts from metagenomically-derived viral sequences. Nucleic Acids Res. 45, 39–53. doi: 10.1093/nar/gkw1002

PubMed Abstract | CrossRef Full Text | Google Scholar

Batista, P. J., Chang, H. Y. (2013). Long noncoding RNAs: cellular address codes in development and disease. Cell 152, 1298–1307. doi: 10.1016/j.cell.2013.02.012

PubMed Abstract | CrossRef Full Text | Google Scholar

Bellucci, M., Agostini, F., Masin, M., Tartaglia, G. G. (2011). Predicting protein associations with long noncoding RNAs. Nat. Methods 8, 444–445. doi: 10.1038/nmeth.1611

PubMed Abstract | CrossRef Full Text | Google Scholar

Chen, W., Lei, T., Jin, D., Lin, H., Chou, K. (2014). PseKNC: a flexible web server for generating pseudo K-tuple nucleotide composition. Anal. Biochem. 456, 53–60. doi: 10.1016/j.ab.2014.04.001

PubMed Abstract | CrossRef Full Text | Google Scholar

Chou, K. C. (2001). Prediction of protein cellular attributes using pseudo-amino acid composition. Proteins-Struct. Funct. And Bioinf. 43, 246–255. doi: 10.1002/prot.1035

CrossRef Full Text | Google Scholar

Chou, K. C. (2005). Using amphiphilic pseudo amino acid composition to predict enzyme subfamily classes. Bioinf. 21, 10–19. doi: 10.1093/bioinformatics/bth466

CrossRef Full Text | Google Scholar

Deng, L., Wang, J., Xiao, Y., Wang, Z., Liu, H. (2018). Accurate prediction of protein-lncRNA interactions by diffusion and HeteSim features across heterogeneous network. BMC Bioinf. 19, 370. doi: 10.1186/s12859-018-2390-0

CrossRef Full Text | Google Scholar

Djebali, S., Davis, C. A., Merkel, A., Dobin, A., Lassmann, T., Mortazavi, A., et al. (2012). Landscape of transcription in human cells. Nat. 489, 101–108. doi: 10.1038/nature11233

CrossRef Full Text | Google Scholar

Fang, Y., Fullwood, M. J. (2016). Roles, functions, and mechanisms of long non-coding RNAs in cancer. Genomics Proteomics Bioinf. 14, 42–54. doi: 10.1016/j.gpb.2015.09.006

CrossRef Full Text | Google Scholar

Fang, S., Zhang, L., Guo, J., Niu, Y., Wu, Y., Li, H., et al. (2018). NONCODEV5: a comprehensive annotation database for long non-coding RNAs. Nucleic Acids Res. 46, D308–D314. doi: 10.1093/nar/gkx1107

PubMed Abstract | CrossRef Full Text | Google Scholar

Franceschini, A., Szklarczyk, D., Frankild, S., Kuhn, M., Simonovic, M., Roth, A., et al. (2012). STRING v9.1: protein-protein interaction networks, with increased coverage and integration. Nucleic Acids Res. 41, D808–D815. doi: 10.1093/nar/gks1094

PubMed Abstract | CrossRef Full Text | Google Scholar

Ge, M., Li, A., Wang, M. (2016). A bipartite network-based method for prediction of long non-coding RNA–protein interactions. Genomics Proteomics Bioinf. 14, 62–71. doi: 10.1016/j.gpb.2016.01.004

CrossRef Full Text | Google Scholar

Guo, S. H., Deng, E. Z., Xu, L. Q., Ding, H., Lin, H., Chen, W., et al. (2014). iNuc-PseKNC: a sequence-based predictor for predicting nucleosome positioning in genomes with pseudo k-tuple nucleotide composition. Bioinf. 30, 1522–1529. doi: 10.1093/bioinformatics/btu083

CrossRef Full Text | Google Scholar

Hao, Y., Wu, W., Li, H., Yuan, J., Luo, J., Zhao, Y., et al. (2016). NPInter v3.0: an upgraded database of noncoding RNA-associated interactions. Database. doi: 10.1093/database/baw057

CrossRef Full Text | Google Scholar

Hu, H., Zhang, L., Ai, H., Zhang, H., Fan, Y., Zhao, Q., et al. (2018). HLPI-Ensemble: prediction of human lncRNA-protein interactions based on ensemble strategy. RNA Biol. 15, 797–806. doi: 10.1080/15476286.2018.1457935

PubMed Abstract | CrossRef Full Text | Google Scholar

Jiang, J. J., Conrath, D., Jiang, J. J., Conrath, D. W. (1997) Semantic similarity based on corpus statistics and lexical taxonomy. In: In Tenth International Conference on Research on Computational Linguistics (ROCLING, X). (Ed.)

Google Scholar

Khalil, A. M., Rinn, J. L. (2011). RNA–protein interactions in human health and disease. Semin. In Cell Dev. Biol. 22, 359–365. doi: 10.1016/j.semcdb.2011.02.016

CrossRef Full Text | Google Scholar

Kirk, J. M., Kim, S. O., Inoue, K., Smola, M. J., Lee, D. M., Schertzer, M. D., et al. (2018). Functional classification of long non-coding RNAs by k-mer content. Nat. Genet. 50, 1474–1482. doi: 10.1038/s41588-018-0207-8

PubMed Abstract | CrossRef Full Text | Google Scholar

Li, A., Ge, M., Zhang, Y., Peng, C., Wang, M. (2015). Predicting Long Noncoding RNA and Protein Interactions Using Heterogeneous Network Model. BioMed. Res. Int. 2015, 1–11. doi: 10.1155/2015/671950

CrossRef Full Text | Google Scholar

Lin, D. (1998). In Proceedings of the Fifteenth International Conference on Machine Learning in An Information-Theoretic Definition of Similarity. lcml. 296–304.

Google Scholar

Liu, B., Liu, F., Fang, L., Wang, X., Chou, K. C. (2015). repDNA: a Python package to generate various modes of feature vectors for DNA sequences by incorporating user-defined physicochemical properties and sequence-order effects. Bioinf. 31, 1307–1309. doi: 10.1093/bioinformatics/btu820

CrossRef Full Text | Google Scholar

Liu, Y., Wu, M., Miao, C., Zhao, P., Li, X. (2016). Neighborhood Regularized Logistic Matrix Factorization for Drug-Target Interaction Prediction. PloS Comput. Biol. 12, e1004760. doi: 10.1371/journal.pcbi.1004760

PubMed Abstract | CrossRef Full Text | Google Scholar

Liu, C. (2004). NONCODE: an integrated knowledge database of non-coding RNAs. Nucleic Acids Res. 33, D112–D115. doi: 10.1093/nar/gki041

CrossRef Full Text | Google Scholar

Lu, Q., Ren, S., Lu, M., Zhang, Y., Zhu, D., Zhang, X., et al. (2013). Computational prediction of associations between long non-coding RNAs and proteins. BMC Genomics 14, 651. doi: 10.1186/1471-2164-14-651

PubMed Abstract | CrossRef Full Text | Google Scholar

Ma, Y., Ge, L., Ma, Y., Jiang, X., He, T., Hu, X. (2018a). “2018 IEEE International Conference on Bioinformatics and Biomedicine (BIBM),” in Kernel Soft-neighborhood Network Fusion for MiRNA-Disease Interaction Prediction. IEEE, 197–200. doi: 10.1109/BIBM.2018.8621122

CrossRef Full Text | Google Scholar

Ma, Y., Yu, L., He, T., Hu, X., Jiang, X. (2018b). 2018 IEEE International Conference on Bioinformatics and Biomedicine (BIBM), in Prediction of Long Non-coding RNA-protein Interaction through Kernel Soft-neighborhood Similarity. IEEE, 193–196. doi: 10.1109/BIBM.2018.8621460

CrossRef Full Text | Google Scholar

Mattick, J. S. (2005). The functional genomics of noncoding RNA. Science 309, 1527–1528. doi: 10.1126/science.1117806

PubMed Abstract | CrossRef Full Text | Google Scholar

Nourania, E., Khunjush, F., Durmuş, S. (2016). Computational prediction of virus-human protein-protein interactions using embedding kernelized heterogeneous data. Mol. Biosyst. 12, 1976–1986. doi: 10.1039/C6MB00065G

PubMed Abstract | CrossRef Full Text | Google Scholar

Pan, X., Shen, H. (2017). RNA-protein binding motifs mining with a new hybrid deep learning based cross-domain knowledge integration approach. BMC Bioinf. 18, 136. doi: 10.1186/s12859-017-1561-8

CrossRef Full Text | Google Scholar

Resnik, P. (1999). Semantic similarity in a taxonomy: an information-based measure and its application to problems of ambiguity in natural language J. Artif. Intell. Res. 11, 95–130. doi: 10.1186/s12859-017-1561-8

CrossRef Full Text | Google Scholar

Shen, J., Zhang, J., Luo, X., Zhu, W., Yu, K., Chen, K., et al. (2007). Predicting protein-protein interactions based only on sequences information. Proc. Natl. Acad. Sci. U. S. A 104, 4337–4341. doi: 10.1073/pnas.0607879104

PubMed Abstract | CrossRef Full Text | Google Scholar

Song, K., Ren, J., Reinert, G., Deng, M., Waterman, M. S., Sun, F. (2014). New developments of alignment-free sequence comparison: measures, statistics and next-generation sequencing. Briefings Bioinf. 15, 343–353. doi: 10.1093/bib/bbt067

CrossRef Full Text | Google Scholar

Suresh, V., Liu, L., Adjeroh, D., Zhou, X. (2015). RPI-Pred: predicting ncRNA-protein interaction using sequence and structural information. Nucleic Acids Res. 43, 1370–1379. doi: 10.1093/nar/gkv020

PubMed Abstract | CrossRef Full Text | Google Scholar

Ulf Andersson ørom, T. D. M. B., Bussotti, G., Lai, F., Zytnicki, M., Notredame, C., Huang, Q., et al. (2010). Long Noncoding RNAs with Enhancer-like Function in Human Cells. Cell 143, 46–58. doi: 10.1016/j.cell.2010.09.001

PubMed Abstract | CrossRef Full Text | Google Scholar

Volders, P., Helsens, K., Wang, X., Menten, B., Martens, L., Gevaert, K., et al. (2013). LNCipedia: a database for annotated human lncRNA transcript sequences and structures. Nucleic Acids Res. 41, D246–D251. doi: 10.1093/nar/gks915

PubMed Abstract | CrossRef Full Text | Google Scholar

Wang, J. Z., Du, Z., Payattakool, R., Yu, P. S., Chen, C. (2007). A new method to measure the semantic similarity of GO terms. Bioinf. 23, 1274–1281. doi: 10.1093/bioinformatics/btm087

CrossRef Full Text | Google Scholar

Wang, S., Cho, H., Zhai, C., Berger, B., Peng, J. (2015). Exploiting ontology graph for predicting sparsely annotated gene function. Bioinf. 31, i357–i364. doi: 10.1093/bioinformatics/btv260

CrossRef Full Text | Google Scholar

Wapinski, O., Chang, H. Y. (2011). Long noncoding RNAs and human disease. Trends In Cell Biol. 21, 354–361. doi: 10.1016/j.tcb.2011.04.001

CrossRef Full Text | Google Scholar

Wu, T., Wang, J., Liu, C., Zhang, Y., Shi, B., Zhu, X., et al. (2006). NPInter: the noncoding RNAs and protein related biomacromolecules interaction database. Nucleic Acids Res. 34, D150–D152. doi: 10.1093/nar/gkj025

PubMed Abstract | CrossRef Full Text | Google Scholar

Xiao, N., Cao, D., Zhu, M., Xu, Q. (2015). protr/ProtrWeb: R package and web server for generating various numerical representation schemes of protein sequences. Bioinf. 31, 1857–1859. doi: 10.1093/bioinformatics/btv042

CrossRef Full Text | Google Scholar

Xiao, Y., Zhang, J., Deng, L. (2017). Prediction of lncRNA-protein interactions using HeteSim scores based on heterogeneous networks. Sci. Rep. 7, 3664. doi: 10.1038/s41598-017-03986-1

PubMed Abstract | CrossRef Full Text | Google Scholar

Xiao, Q., Luo, J., Liang, C., Cai, J., Ding, P. (2018). A graph regularized non-negative matrix factorization method for identifying microRNA-disease associations. Bioinf. 34, 239–248. doi: 10.1093/bioinformatics/btx545

CrossRef Full Text | Google Scholar

Xie, C., Yuan, J., Li, H., Li, M., Zhao, G., Bu, D., et al. (2013). NONCODEv4: exploring the world of long non-coding RNA genes. Nucleic Acids Res. 42, D98–D103. doi: 10.1093/nar/gkt1222

PubMed Abstract | CrossRef Full Text | Google Scholar

Yu, G., Li, F., Qin, Y., Bo, X., Wu, Y., Wang, S. (2010). GOSemSim: an R package for measuring semantic similarity among GO terms and gene products. Bioinf. 26, 976–978. doi: 10.1093/bioinformatics/btq064

CrossRef Full Text | Google Scholar

Yuan, J., Wu, W., Xie, C., Zhao, G., Zhao, Y., Chen, R. (2013). NPInter v2.0: an updated database of ncRNA interactions. Nucleic Acids Res. 42, D104–D108. doi: 10.1093/nar/gkt1057

PubMed Abstract | CrossRef Full Text | Google Scholar

Zhang, W., Qu, Q., Zhang, Y., Wang, W. (2018a). The linear neighborhood propagation method for predicting long non-coding RNA–protein interactions. Neurocomputing. 273, 526–534. doi: 10.1016/j.neucom.2017.07.065

CrossRef Full Text | Google Scholar

Zhang, W., Yue, X., Tang, G., Wu, W., Huang, F., Zhang, X. (2018b). SFPEL-LPI: Sequence-based feature projection ensemble learning for predicting LncRNA-protein interactions. PloS Comput. Biol. 14, e1006616. doi: 10.1371/journal.pcbi.1006616

PubMed Abstract | CrossRef Full Text | Google Scholar

Zheng, X., Ding, H., Mamitsuka, H., Zhu, S. (2013). "KDD '13 Proceedings of the 19th ACM SIGKDD international conference on Knowledge discovery and data mining" in Collaborative Matrix Factorization with Multiple Similarities for Predicting Drug-Target Interactions. ACM, 1025–1033. doi: 10.1145/2487575.2487670

CrossRef Full Text | Google Scholar

Zheng, X., Wang, Y., Tian, K., Zhou, J., Guan, J., Luo, L., et al. (2017). Fusing multiple protein-protein similarity networks to effectively predict lncRNA-protein interactions. BMC Bioinf. 18, 420. doi: 10.1186/s12859-017-1819-1

CrossRef Full Text | Google Scholar

Keywords: lncRNA-protein interaction, feature projection, neighborhood completion, graph non-negative matrix factorization, kernel neighborhood similarity

Citation: Ma Y, He T and Jiang X (2019) Projection-Based Neighborhood Non-Negative Matrix Factorization for lncRNA-Protein Interaction Prediction. Front. Genet. 10:1148. doi: 10.3389/fgene.2019.01148

Received: 08 August 2019; Accepted: 21 October 2019;
Published: 20 November 2019.

Edited by:

Wen Zhang, Huazhong Agricultural University, China

Reviewed by:

Yang Yang, Shanghai Jiao Tong University, China
Lingling Jin, Thompson Rivers University, Canada
Le Ou-Yang, Shenzhen University, China

Copyright © 2019 Ma, He and Jiang. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Xingpeng Jiang, xpjiang@mail.ccnu.edu.cn

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.