Next Article in Journal
Unraveling Lifelong Brain Morphometric Dynamics: A Protocol for Systematic Review and Meta-Analysis in Healthy Neurodevelopment and Ageing
Next Article in Special Issue
Azadiradione, a Component of Neem Oil, Behaves as a Superoxide Dismutase Mimic When Scavenging the Superoxide Radical, as Shown Using DFT and Hydrodynamic Voltammetry
Previous Article in Journal
The Enigmatic CA2: Exploring the Understudied Region of the Hippocampus and Its Involvement in Parkinson’s Disease
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Predicting Drug–Gene–Disease Associations by Tensor Decomposition for Network-Based Computational Drug Repositioning

1
Division of Software, Yonsei University Mirae Campus, Wonju-si 26493, Gangwon-do, Republic of Korea
2
Division of Digital Healthcare, Yonsei University Mirae Campus, Wonju-si 26493, Gangwon-do, Republic of Korea
*
Author to whom correspondence should be addressed.
Biomedicines 2023, 11(7), 1998; https://doi.org/10.3390/biomedicines11071998
Submission received: 20 June 2023 / Revised: 7 July 2023 / Accepted: 12 July 2023 / Published: 14 July 2023
(This article belongs to the Special Issue Recent Advances in Drug Repositioning)

Abstract

:
Drug repositioning offers the significant advantage of greatly reducing the cost and time of drug discovery by identifying new therapeutic indications for existing drugs. In particular, computational approaches using networks in drug repositioning have attracted attention for inferring potential associations between drugs and diseases efficiently based on the network connectivity. In this article, we proposed a network-based drug repositioning method to construct a drug–gene–disease tensor by integrating drug–disease, drug–gene, and disease–gene associations and predict drug–gene–disease triple associations through tensor decomposition. The proposed method, which ensembles generalized tensor decomposition (GTD) and multi-layer perceptron (MLP), models drug–gene–disease associations through GTD and learns the features of drugs, genes, and diseases through MLP, providing more flexibility and non-linearity than conventional tensor decomposition. We experimented with drug–gene–disease association prediction using two distinct networks created by chemical structures and ATC codes as drug features. Moreover, we leveraged drug, gene, and disease latent vectors obtained from the predicted triple associations to predict drug–disease, drug–gene, and disease–gene pairwise associations. Our experimental results revealed that the proposed ensemble method was superior for triple association prediction. The ensemble model achieved an AUC of 0.96 in predicting triple associations for new drugs, resulting in an approximately 7% improvement over the performance of existing models. It also showed competitive accuracy for pairwise association prediction compared with previous methods. This study demonstrated that incorporating genetic information leads to notable advancements in drug repositioning.

1. Introduction

Drug repositioning, which identifies additional therapeutic indications for drugs that have already been commercialized, has gained attention owing to its ability to significantly reduce the time and cost required to develop novel drugs [1]. This approach is appealing to the pharmaceutical industry because there is a substantial pool of drugs that have been developed and approved but are underutilized. In particular, computational methods have shown promise in this field by inferring potential associations between drugs and diseases efficiently [2]. For effective repositioning of drugs, it is crucial to identify the proteins targeted by drugs or genes causing diseases, as drugs function by inhibiting or activating specific genes. Computational techniques extensively analyze omics data, including drugs, diseases, disease-causing genes, and drug–targeted proteins, to narrow down the list of candidates for experimental drug repositioning. The rapid accumulation of such data has been facilitated by advancements in genomics, proteomics, and systems biology.
Initially, the early research in the domain of computational drug repositioning primarily focused on uncovering the interactions between a drug and its molecular targets [3,4,5]. Evidence of drug–target interactions (DTIs) serves as a significant clue for drug repositioning based on the underlying assumption that multiple drugs interact with multiple targets [6]. Previous DTI prediction methods have often explored networks such as drug–target bipartite networks [7,8] to infer new targets for each drug. For example, BLM-NII [9] employed a neighbor-based interaction-profile inference (NII) algorithm to predict DTIs within the bipartite local model (BLM), which cannot be learned in the absence of known interactions. WNN-GIP [10] constructed interaction profiles for drugs and proteins using the weighted nearest neighbor (WNN) algorithm, enhanced interaction evidence through the Gaussian interaction profile kernel (GIP), and predicted DTIs using normalized least-squares (RLS). NetLapRLS [11] adopted the Laplace regularized least-squares method for DTI prediction. MSCMF [12] integrated multiple drug and disease similarity matrices, updating the weights for low-rank similarity matrices of drugs and targets using the cross-alternative least-squares algorithm. BRDTI [13] extended the Bayesian personalized ranking matrix factorization method to match drugs and targets even in the absence of positive samples, such as new drugs. More advanced methods employed complex heterogeneous networks, incorporating both drugs and target proteins, for predicting DTIs [14,15,16].
Recent disease studies that aim to identify disease-causing genes have revealed an increasing trend towards network-based analysis. Networks have become essential tools for prioritizing genes associated with a disease [17]. Numerous network-based methods have been proposed for predicting disease–gene associations [18,19]. These methods operate under the assumption that genes responsible for the same disease tend to be located in close proximity within a disease network. For example, PRINCE [20] applied a network propagation algorithm to a disease–gene heterogeneous network to predict disease–gene associations. A homogeneous network comprises nodes of a single type and their connections, whereas a heterogeneous network is comprised of two or more types of nodes and their connections. HerGePred [21] performed a random walk with restart on a disease–gene heterogeneous network, incorporating network embeddings, such as node2vec, to obtain low-dimensional vectors and reconstruct the networks based on their similarities.
Most computational drug repositioning approaches for predicting drug–disease associations also address the challenges posed by heterogeneous networks that incorporate various features of drugs and diseases [22]. Network-based methods can be categorized into three groups based on their key techniques. The first group applies graph mining algorithms, such as random walk, network propagation, path search, and clustering, to detect putative associations between drug and disease pairs that are not directly linked in a heterogeneous network. For example, TL-HGBI [23] integrated drug, disease, and gene similarities into a three-layer heterogeneous network and inferred drug–disease associations using an information propagation algorithm. MBiRW [24] predicted drug–disease associations using a bi-random walk algorithm on a heterogeneous network constructed using drug and disease similarities. DR-IBRW [25] employed dual random work based on the concept that each node in the network has a distinct walk length to facilitate the dissemination of information.
The second group of drug–disease association prediction approaches uses deep learning algorithms, including autoencoders and graph convolutional networks, to extract network features and construct predictive models. For deepDR [26], common features from nine drug similarity networks were extracted using a multi-modal deep autoencoder. These features, along with drug–disease associations, were then input into a collective variable autoencoder to infer novel indications for a given drug. ANMF [27] predicted associations by leveraging the drug and disease features extracted through an autoencoder by multiplying them.
The last group of approaches to predict drug–disease associations employs matrix factorization or matrix completion techniques, which are based on collaborative filtering methods that analyze correlations between entities. A collection of drug–disease associations is represented in a matrix form, and matrix factorization is applied to decompose it into two matrices of latent features representing drugs and diseases. The predictive scores for drug–disease associations are then computed by multiplying the two latent feature matrices. For example, MSBMF [28] performed matrix decomposition by combining multiple drug–drug and disease–disease similarity networks to identify new indications. NMF-DR [29] constructed a heterogeneous drug–disease network and performed non-negative matrix decomposition. SCPMF [30] used each similarity as a constraint on drugs and viruses during matrix decomposition to predict associations between drugs and viruses. Instead of constructing a single heterogeneous network, OMC [31] adopted separate matrix completion techniques to handle drug and disease networks independently.
Most matrix factorization methods, as described above, focus primarily on utilizing drug and disease networks. However, considering that genes also interact closely with drugs and diseases, incorporating features of all three components can lead to more accurate outcomes not only in drug–disease association prediction, but also in DTI and disease–gene association prediction. Tensors are commonly used to integrate these components. Tensor decomposition, which extends the concept of matrix decomposition to multiple dimensions, can be applied to discover novel associations among these components [32]. For example, Wang et al. [33] constructed a drug–target-disease tensor by combining drug–disease, drug–target, and disease–target associations and predicted drug–target-disease associations through tensor decomposition. NTD-DR [34] performed non-negative tensor decomposition on a drug–target-disease tensor for drug repositioning. Non-negative tensor decomposition was enhanced with additional constraints based on similarities and associations between drugs, targets, and diseases. TDRC [35] placed constraints related to biological similarity during tensor decomposition to identify links between microRNAs and diseases.
In this article, we present a network-based approach for computational drug repositioning that leverages a drug–gene–disease tensor containing drug–disease, drug–gene, and disease–gene associations. We employed tensor decomposition to predict drug–gene–disease triple associations. Additionally, we can predict pairwise associations by constructing drug–disease, drug–gene, and disease–gene matrices from latent factor matrices obtained through tensor decomposition.
However, tensor decomposition alone fails to capture the complex structure of drug–gene–disease associations and does not fully utilize the additional information available on drugs, genes, and diseases. This limitation arises because the tensor decomposition yields latent factor matrices through linear combinations. To overcome these limitations, neural network models can be employed because they excel at modeling nonlinear relationships and extracting diverse features from multiple datasets. Therefore, we propose a novel method for predicting drug–gene–disease triple associations by extending tensor decomposition to a nonlinear model. This method incorporates neural network models to handle the features from each dimension effectively. The aim of this study was to assess the degree of accuracy enhancement achieved by using predicted triple associations for computational drug repositioning.

2. Method

2.1. Preliminaries

A tensor is a multidimensional array representing different types of data, with each dimension corresponding to a specific type. It can take various forms such as a scalar when it has zero dimensions, a vector when it has one dimension, and a matrix when it has two dimensions. Tensor decomposition is a generalized technique that extends the decomposition of two-dimensional matrices into higher-dimensional tensors. CANDECOMP/PARAFAC (CP) decomposition [36] is the most widely used tensor decomposition model. The rank-1 tensor is defined as the outer product of these vectors. Then, CP decomposition factorizes tensor X into a sum of rank-1 tensors, as follows:
X r = 1 R a r × b r × c r ;
the symbol × denotes the outer product of vectors a, b, and c. Also, a r R I , b r R J , and c r R K in the range of 1 r R , where I, J, and K represent the dimensions of the tensors. R is a positive number that signifies the tensor rank. The rank of the tensor X is the minimum number of rank-1 tensors required to represent X . The individual elements of the decomposed tensor are expressed as
x i , j , k r = 1 R a i r b j r c k r ,
where 1 i I , 1 j J , 1 k K .

2.2. Proposed Approaches

The prediction of drug–gene–disease associations can be framed as a tensor completion problem involving the drug–gene–disease tensor denoted as X R I × J × K where I, J, and K indicate the number of drugs, genes, and diseases, respectively. When drug i is used to treat disease k, drug i binds to gene j, and disease k is caused by gene j, a triple link is considered to exist among drug i, gene j, and disease k, thereby setting the corresponding element x i j k of the tensor to 1. Initially, the remaining elements not associated with drug–gene–disease interactions are assigned a value of 0, and our goal was to estimate the scores for these other elements.
ID embedding vectors for drug i, gene j, and disease k are typically regarded as latent vectors for drugs, genes, and diseases, respectively [37]. Additional biological features pertaining to drugs, genes, and diseases can be provided as supplementary inputs. The drug–drug, gene–gene, and disease–disease similarities are utilized as extra information and normalized within the range of 0 to 1. Ultimately, the two sets of features, namely, the ID embedding and similarity vectors, are combined by concatenation as follows:
d r i = d r i d i d r s i m i , g e j = g e i d j g e s i m j , d i k = d i i d k d i s i m k .
These combined vectors are taken as inputs of the fully connected neural network to convert the embeddings to a uniform size, a i R r , b j R r , and c k R r .
The proposed approach comprises two components: generalized tensor decomposition (GTD) and multi-layer perceptron (MLP). The GTD [36] extends CP decomposition to effectively capture the associations among drugs, genes, and diseases. Consequently, the embeddings obtained for drugs, genes, and diseases via the fully connected neural layers can be interpreted as latent vectors. The functions that map the drug–gene–disease associations can be defined as follows:
ϕ G T D ( a i , b j , c k ) = a i b j c k ,
where ⊙ denotes the element-wise product of the vectors a i , b j , and c k . These vectors are projected onto the output layer to create a tensor containing the estimated scores, as follows:
X ^ i , j , k = σ ( h T ( a i b j c k ) ) ,
where σ is an activation function and h denotes a vector for edge weights in the output layer. This model was transformed into a CP decomposition by utilizing the identity function and uniform vector of 1 as σ and h, respectively. In other words, GTD represents an extension of CP decomposition to a nonlinear model, enabling it to effectively capture the complex structure of drug–gene–disease associations. In our approach, we employed the sigmoid function as σ to ensure that the output values lie within the range of 0 to 1, whereas h is learned from the data.
Although GTD effectively models drug–gene–disease associations, it does not fully capture the individual features of drugs, genes, and diseases, as latent vectors are not treated independently. To address this limitation, we incorporate an MLP model to independently learn drug, gene, and disease features. The multi-layer structure of the MLP is constructed as follows: initially, the latent vectors a i , b j , and c k corresponding to the drugs, genes, and diseases, respectively, are provided as inputs to the MLP.
z d r ( 0 ) = ϕ d r ( 0 ) ( a i ) = a i ,
z g e ( 0 ) = ϕ g e ( 0 ) ( b j ) = b j ,
z d i ( 0 ) = ϕ d i ( 0 ) ( c k ) = c k .
The operations performed in the first hidden layer are as follows: The outputs of the previous layers, z d r ( 0 ) , z g e ( 0 ) , and z d i ( 0 ) , are considered as inputs multiplied by the weight matrices of the first layer, W d r ( 1 ) , W g e ( 1 ) , and W d i ( 1 ) , respectively. In addition, the biases of the first layer, represented as b d r ( 1 ) , b g e ( 1 ) , and b d i ( 1 ) , are added to activate this function.
ϕ d r ( 1 ) ( z d r ( 0 ) ) = σ d r ( 1 ) ( W d r ( 1 ) T z d r ( 0 ) + b d r ( 1 ) ) ,
ϕ g e ( 1 ) ( z g e ( 0 ) ) = σ g e ( 1 ) ( W g e ( 1 ) T z g e ( 0 ) + b g e ( 1 ) ) ,
ϕ d i ( 1 ) ( z d i ( 0 ) ) = σ d i ( 1 ) ( W d i ( 1 ) T z d i ( 0 ) + b d i ( 1 ) ) .
These operations are iteratively performed until reaching the L-th layer.
ϕ d r ( L ) ( z d r ( L 1 ) ) = σ d r ( L ) ( W d r ( L ) T z d r ( L 1 ) + b d r ( L ) ) ,
ϕ g e ( L ) ( z g e ( L 1 ) ) = σ g e ( L ) ( W g e ( L ) T z g e ( L 1 ) + b g e ( L ) ) ,
ϕ d i ( L ) ( z d i ( L 1 ) ) = σ d i ( L ) ( W d i ( L ) T z d i ( L 1 ) + b d i ( L ) ) .
Finally, the tensor containing the scores for drug–gene–disease associations can be derived by taking the element-wise product of the three components.
X ^ i j k = σ ( h T ( ϕ d r ( L ) ( z d r ( L 1 ) ) ϕ g e ( L ) ( z g e ( L 1 ) ) ϕ d i ( L ) ( z d i ( L 1 ) ) ) ) .
The MLP structure follows a tower pattern characterized by multiple layers, where the bottom layer has the greatest number of neurons and the subsequent layers have gradually decreasing numbers of neurons. Drug, gene, and disease features learned independently through the MLP are regarded as latent vectors representing drugs, genes, and diseases, respectively.
As mentioned earlier, GTD extends CP decomposition to model drug–gene–disease associations, whereas MLP identifies complex features of drugs, genes, and diseases. In this study, we propose a novel approach that combines the elements of the GTD and MLP. This model integrates an input consisting of ID embedding vectors and similarities and applies both GTD and MLP. The resulting drug, gene, and disease latent vectors from the GTD and MLP are merged to generate the final latent vectors and predict the drug–gene–disease associations. By leveraging GTD for modeling associations and MLP for learning features, this approach offers greater flexibility and non-linearity than traditional tensor decomposition methods, allowing it to capture complex drug–gene–disease associations.

3. Data

For our experiments, we created drug–gene–disease tensors based on drug–disease, drug–gene, and disease–gene associations. We also constructed similarity networks using biological features associated with drugs, genes, and diseases. The tensors and similarity networks were acquired as described below.

3.1. Pairwise Associations

First, we used drug–disease associations from the Cdataset [24], a widely recognized benchmark dataset for validating computational drug repositioning methods. This dataset combines data from the Fdataset [38] and the DNdataset [39], containing 663 distinct drugs from DrugBank [40], 409 diseases from Online Mendelian Inheritance in Man (OMIM) [41] and 2352 known drug–disease associations. Next, we extracted drug–gene associations from the Comparative Toxicogenomic Database (CTD) [42], which provides not only interactions between chemicals and genes, specifically DTIs, but also offers insights into their associations with diseases. The CAS numbers of the drugs were mapped to gene symbols. Finally, we obtained disease–gene associations from OMIM, a comprehensive resource offering extensive information on human genes and phenotypes, including various disorders.

3.2. Drug Similarity Networks

To construct drug similarity networks as supplementary information, we used DrugBank 5.0 [40], which provides a wide range of drug features, including chemical structures, anatomical therapeutic chemical classification system (ATC) codes [43], targets, and side effects. This comprehensive database encompasses both drugs approved by Food and Drug Administration (FDA) and experimental drugs undergoing approval procedures. We considered both approved and experimental drugs for drug similarity networks, as drug repositioning aims to identify new therapeutic indications for not only already commercialized drugs, but also those that were not brought to the market due to insufficient clinical efficacy. In our experiment, we used two distinct drug similarity networks based on chemical structures and ATC codes.
Drugs with similar chemical structures tend to exhibit similar features. The chemical structures of the drugs are stored in DrugBank using the simplified molecular input line entry system (SMILES) notation [44], which represents structures as strings. We used this information to calculate drug–drug similarities by employing a chemistry development kit (CDK) [45], an open-source library specializing in structural chemistry and bioinformatics. From the drugs included in the Cdataset, a drug similarity network was established based on the chemical structures of 659 drugs with available SMILES information from DrugBank.
The ATC code, a drug classification system devised by the World Health Organization (WHO), classifies drugs into the categories from five levels. We considered two drugs to be similar if they shared the same code at any classification level. The similarity between drugs d i and d j based on the k-th level of the ATC codes was defined as follows [46]:
S k ( d i , d j ) = A T C k ( d i ) A T C k ( d j ) A T C k ( d i ) A T C k ( d j ) .
A T C k represents a set of codes corresponding to the k-th level of all ATC codes assigned to a particular drug. It is important to note that a single drug can be associated with multiple ATC codes. Finally, the similarity between drugs was calculated by averaging their similarities across all levels.
s i m a t c ( d i , d j ) = k = 1 n S k ( d i , d j ) n ,
where n = 5 because the ATC codes are composed of five levels. From the drugs present in the Cdataset, a drug similarity network was constructed based on ATC codes, involving 636 drugs for which ATC code information was available in DrugBank.

3.3. Gene Similarity Networks

An ontology is a hierarchical arrangement of terms, in which those with more specific meanings are assigned to subsets. Typically, this organization takes the form of a directed acyclic graph, with edges representing parent–child relationships between the terms. Gene Ontology (GO) [47] is the most widely referenced ontology in this field. It comprises terms that serve as biological descriptions with genes annotated to their corresponding terms. By leveraging the GO structure and annotations, we can classify the biological roles of these genes.
Assuming that similar genes perform similar functions, we can measure the similarity between genes by assessing the semantic similarity between the GO terms to which they are annotated. We employed a semantic similarity metric [48] to calculate the ratio of information content for common GO terms as follows:
s i m T C 1 , C 2 = C i A t ( C 1 ) A t ( C 2 ) l o g P ( C i ) C j A t ( C 1 ) A t ( C 2 ) l o g P ( C j ) ,
where C 1 and C 2 are GO terms, A t C i denotes the set of ancestral terms of C i , P ( C i ) signifies the proportion of genes annotated to C i , and l o g P ( C i ) indicates the information content of C i . Given that genes can be annotated to multiple terms, we computed the similarity between two genes using the best matching average of all the term pairs in which the genes were annotated.
s i m ( g 1 , g 2 ) = C i T ( g 1 ) m a x C j T ( g 2 ) s i m T ( C i , C j ) + C j T ( g 2 ) m a x C i T ( g 1 ) s i m T ( C i , C j ) | T ( g 1 ) | + | T ( g 2 ) | ,
where T ( g ) represents the set of GO terms to which the gene g is annotated. This formula was applied to the sub-ontologies of biological processes and molecular functions in GO. To enhance the data reliability, annotations with the evidence code of IEA or qualifiers indicating “not” were excluded from this experiment.
A gene similarity network was generated by retrieving protein–protein interactions (PPIs) from BioGRID [49]. Subsequently, the similarities of interacting pairs in the refined set of PPIs were computed after deleting redundant links and self-loops. To further address network sparsity, genes with fewer than 10 drug–gene or disease–gene associations were excluded. Finally, a similarity network consisting of 7824 genes was constructed.

3.4. Disease Similarity Networks

Similar to the gene similarity network, we created a disease similarity network by calculating semantic similarities between diseases using the Human Phenotype Ontology (HPO) [50] and its annotations. The HPO is an ontology that classifies phenotypes associated with human diseases and mutations. Assuming that similar diseases exhibit shared symptoms, the similarity between diseases was measured by the semantic similarity between the HPO terms to which the diseases were annotated. Formula (18) was employed to calculate semantic similarity and Formula (19) was used to determine the similarity between the diseases. For semantic similarity, we focused on sub-terms of “Phenotypic Abnormality” in HPO and excluded diseases annotated with the evidence code of IEA. The HPO includes annotations of more than 50,000 diseases from OMIM [41], OrphaNet [51], and DECIPHER [52]. For this experiment, we selected diseases from OMIM. The resulting disease similarity network consisted of 285 diseases from the Cdataset. Table 1 provides an overview of the number of nodes and edges in the drug, gene, and disease similarity networks.

3.5. Drug–Gene–Disease Tensors

Based on the drug features of chemical structures and ATC codes, we generated two distinct drug–gene–disease tensors. The tensor using the chemical structures of drugs contained 252 drug–gene–disease triple associations, including 659 drugs, 7824 genes, and 285 diseases. In contrast, the tensor based on the ATC codes of drugs contained 251 drug–gene–disease triple associations, involving 636 drugs, 7824 genes, and 285 diseases. Consequently, both the tensors exhibited similar levels of sparsity. Please refer to Table 2 for the drug–disease, drug–gene, and disease–gene pairwise associations employed in creating drug–gene–disease tensors.

4. Results

Experiments for drug–gene–disease triple-association prediction were conducted separately on the drug and disease sides. On the drug side, we examined the prediction of triple associations for a novel drug without any known drug–disease or drug–gene associations. This experiment involved the prediction of genes interacting with the new drug and diseases resulting from mutations in these genes. Conversely, on the disease side, we tested the prediction of triple associations for a new disease without any known drug–disease or disease–gene associations. The objective was to predict the genes responsible for the new disease and drugs targeting these genes. To evaluate the performance of the drug–gene–disease association prediction, we conducted a 10-fold cross-validation for each side. The folds were partitioned to ensure an even distribution of known triple associations.
The drug–gene–disease tensor X is typically very sparse owing to the limited number of drug–disease, drug–gene, and disease–gene associations. This sparsity causes a severe imbalance between positive and negative samples, which can hinder model learning. To address this issue, we introduced negative samples by randomly selecting 10 unlinked elements between the drugs, genes, and diseases for each positive sample. This strategy resulted in a positive-to-negative sample ratio of 1 to 10.
The performance of the predictive model was assessed using two evaluation metrics: the area under the ROC curve (AUC) and normalized discrete cumulative gain (NDCG). The ROC curve was plotted by tracking the true-positive rate as the false-positive rate increases, and the area below the ROC curve is an indicator of the predictive accuracy of the binary classification models. The true-positive rate represents the proportion of samples correctly predicted to be positive among all positive samples, whereas the false-positive rate represents the proportion of samples incorrectly predicted to be positive among all negative samples.
The NDCG is an evaluation metric used in ranking-based recommendation systems. It assesses the quality of the top n predicted drug–gene–disease associations by assigning higher weights to those that are ranked more prominently. NDCG was calculated by normalizing the discounted cumulative gain (DCG) to ideal DCG (IDCG). The DCG was determined based on the relevance scores and rankings of the recommendation results.
D C G = i = 1 n r e l i l o g 2 ( i + 1 ) ,
where r e l represents the relevance score assigned to the recommended results and n denotes the total number of ranked results used for evaluation. IDCG represents the DCG value when all recommended results are perfectly ordered. Both the AUC and NDCG values range between 0 and 1. Values closer to 1 indicate better predictive accuracy of the models.

4.1. Predicting Drug–Gene–Disease Triple Associations

First, we evaluated the performance of predicting drug–gene–disease triple associations on the drug side. This involved predicting associations for each drug without any prior knowledge of drug–disease or drug–gene associations. For the experimental dataset, we created a balanced set by randomly sampling 10 negative samples for each positive sample. To facilitate learning, positive and negative association pairs were divided into 10 folds based on the drugs. One fold was used for validation to terminate early if the performance did not improve, preventing the model from overfitting. Based on the prediction scores of the selected drug–disease pairs, we assessed the performance of the GTD, MLP, and their ensemble models using AUC and NDCG@n. The NDCG@n metric evaluates the accuracy of the top n associations based on their prediction scores. The results of the proposed approaches were compared with those of NTD-DR [34], which is a conventional tensor decomposition method for drug repositioning.
The predictive accuracies on the drug side with respect to the AUC and NDCG@n scores with n values of 1, 3, 5, and 10 are presented in Table 3. The proposed ensemble model consistently exhibited the highest predictive accuracy across both drug features as additional information. NTD-DR showed a lower overall accuracy than the proposed approach. When comparing the GTD and MLP, MLP performed better than GTD in terms of AUC. However, in terms of NDCG, the performance varied depending on the drug features. Specifically, when drug–drug similarity was measured using chemical structures, GTD achieved higher NDCG values than MLP. In contrast, the MLP, which learns drug, gene, and disease features individually, performed better than the GTD when similarity based on ATC codes was used.
Figure 1 shows the ROC curves of the drug–gene–disease association prediction experiments for a novel drug. Figure 1a shows the results from the drug similarity networks using chemical structures, while Figure 1b shows the results from the ATC code-based drug similarity networks. In both graphs, the proposed ensemble model and MLP exhibit a steep increase in the true-positive rate and are positioned in the upper-left corner. In contrast, NTD-DR and GTD show gradual increases in the true-positive rate as the false-positive rate increases.
Next, we evaluated the predictive performance of the drug–gene–disease triple associations on the disease side. This involved predicting associations for each disease without any prior knowledge of drug–disease or disease–gene associations. Similar to the drug side prediction, we divided the positive and negative association pairs into 10 folds based on diseases for the learning process. The AUC and NDCG results for the predictive outcomes on the disease side are presented in Table 4. Consistent with the findings in Table 3, the proposed ensemble model demonstrated a superior performance except for the AUC results from the ATC code-based drug similarity network. Although NTD-DR showed the highest AUC value, its NDCG results decreased. In terms of the NDCG index, the MLP ranked second after the ensemble method. These results can be attributed to the fact that AUC reflects classification performance, whereas NDCG considers the ranking of the predicted outcomes. In other words, NTD-DR performed well in determining the presence or absence of drug–gene–disease associations in terms of classification, whereas the MLP excelled in determining the ranking of these associations.
Figure 2 illustrates the ROC curves of the drug–gene–disease association prediction experiments for novel diseases, with (a) representing the results using drug similarity networks based on chemical structures and (b) representing the results using ATC code-based drug similarity networks. Similar to the findings in Figure 1, NTD-DR shows a gradual increase in the true-positive rate as the false-positive rate increases. In contrast, the proposed ensemble model demonstrated a rapid increase in the true-positive rate. These results provide evidence that the ensemble model attained the highest NDCG values, as listed in Table 4.
When comparing the prediction performance between the drug and disease sides, we observed that triple associations were generally better predicted for new drugs than for new diseases. This is primarily due to the larger number of drugs with available drug–gene–disease triple associations compared to the number of diseases. Moreover, when comparing the prediction performance between the two drug features used, the drug similarity network based on ATC codes showed a higher predictive accuracy on both the drug and disease sides than the network based on chemical structures. Finally, in all cases, the performance of the ensemble model was significantly improved over GTD. As the most significant result of this study, the accuracy of drug–gene–disease triple association prediction was enhanced by employing MLP to reflect and learn the distinct features of drugs, genes, and diseases.

4.2. Predicting Drug–Disease Pairwise Associations

The decomposition of drug–disease, drug–gene, and disease–gene matrices yields latent vectors for drugs, genes, and diseases, which can be used to identify pairwise associations between them. The latent vectors obtained through the prediction of drug–gene–disease triple associations, as conducted in previous experiments, also provide evidence of the associations between drugs, genes, and diseases. Consequently, pairwise associations among drugs, genes, and diseases can be predicted by taking the inner product of their corresponding latent vectors obtained from the tensor decomposition of drug–gene–disease associations.
First, drug–disease association prediction was performed using drug and disease latent vectors obtained through the prediction of drug–gene–disease triple associations. In terms of predictive accuracy, this approach was compared to several existing computational drug repositioning methods, namely MBiRW [24], MSBMF [28], OMC [31], and deepDR [26]. Table 5 presents the AUC and NDCG results of the drug–disease association prediction for new drugs without any prior knowledge of drug–disease or drug–gene associations. Overall, OMC, a previous matrix factorization method, and the proposed ensemble model demonstrated the best performance in this evaluation. Unlike other drug repositioning methods, OMC incorporates not only drug–disease associations but also drug–gene and disease–gene associations to capture the features of genes that are targeted by the drug and cause the disease. This result suggests that accurate drug repositioning relies not only on drug features but also on gene and disease features. The deep learning algorithm, deepDR, exhibited relatively poor performance as it did not utilize a disease similarity network, resulting in insufficient incorporation of disease features.

4.3. Predicting Drug–Gene Pairwise Associations

Subsequently, in a manner similar to drug–disease association prediction, drug–gene associations were predicted using latent vectors for drugs and genes obtained through drug–gene–disease triple association prediction. The predictive accuracy of the proposed approach was compared with that of previous DTI prediction methods, specifically NetLapRLS [11], BLM-NII [9], and MSCMF [12]. Table 6 presents the AUC and NDCG results of the drug–gene association prediction for new drugs without any prior knowledge of drug–disease or drug–gene associations. Overall, the proposed ensemble model outperformed the other methods in terms of predictive accuracy, regardless of the drug features employed. GTD also demonstrated a strong performance, particularly in NDCG. GTD and MLP generally showed similar trends to the ensemble model, suggesting that incorporating drug–disease and disease–gene associations, along with disease features, contributes to improved accuracy in predicting drug–gene associations. Among the previous methods, NetLapRLS achieved relatively favorable results in terms of both the AUC and NDCG, particularly when larger values of n were considered.

4.4. Predicting Disease–Gene Pairwise Associations

By prioritizing genes associated with a specific disease based on the prediction scores of disease–gene associations, candidate genes responsible for the disease can be identified. The prediction of disease–gene associations is accomplished using latent vectors representing diseases and genes obtained through drug–gene–disease triple association prediction. Table 7 presents the AUC and NDCG results of the disease–gene association prediction for GTD, MLP, the proposed ensemble model, and existing disease–gene prioritization methods, namely PRINCE [20] and HerGePred [21]. The results demonstrated that the ensemble model, which leverages drug–gene and drug–disease associations, outperformed the other methods in terms of predictive accuracy.

4.5. Hyperparameter Tuning

The rank in the tensor decomposition corresponds to the number of latent factors required to represent the tensor and determines the size of the latent matrix. Generally, a lower rank yields a simpler decomposition result but with reduced accuracy. Conversely, a higher rank produces a more accurate decomposition result but increases the computational complexity and risk of overfitting. Because the optimal rank can vary depending on the size of the data and quality of the features, it is considered a hyperparameter to be chosen.
Figure 3 illustrates the AUC changes according to the rank for the prediction of drug–gene–disease triple associations. Figure 3a,b present the results when utilizing chemical structures as a drug feature, whereas Figure 3c,d display the results using the ATC code-based drug similarity network. Also, Figure 3a,c show the prediction results for new drugs, whereas Figure 3b,d show the prediction results for new diseases. It can be observed that GTD and the ensemble model generally tend to overfit as the rank increases, resulting in poor performance. However, MLP improves the performance as the rank increases, although the rate of improvement gradually diminishes. The rank employed in the previous experiment was determined to be the highest performing rank because no method for identifying the optimal rank in tensor decomposition was available.

4.6. Balancing Training Datasets

The drug–gene–disease tensor used in this experiment exhibited a high level of sparsity, resulting in an imbalance between the positive and negative samples. To address this issue, we randomly selected 10 α negative samples per positive sample, where α represents the proportion of negative to positive samples. Increasing the value of α further exacerbated this imbalance. It is important to note that achieving a balance in the training dataset between positive and negative samples can impact the predictive accuracy of the model, thus necessitating the determination of an appropriate α .
Figure 4 presents the experimental results obtained while exploring the drug–gene–disease triple association prediction to identify the optimal value of α using the drug similarity network of chemical structures (Figure 4a) and the network based on the ATC code (Figure 4b). When α was less than 10, GTD exhibited inaccurate predictions because it did not adequately consider the negative samples in the tensor. When α was set to 10, GTD, MLP, and the ensemble model demonstrated the best predictive performance. However, as α exceeded 10, the accuracy of MLP significantly decreased. This indicates that the model became overfitted to the negative samples as α increased. Consequently, the optimal α for drug–gene–disease triple association prediction was determined to be 10.

5. Discussion and Conclusions

Drug repositioning provides considerable benefits in terms of safety, time, and cost, by identifying new therapeutic indications for existing drugs. Computational approaches are highly anticipated because of their effectiveness in inferring potential associations between drugs and diseases. Over the past few years, numerous network-based drug repositioning methods have been proposed. Moreover, since drugs achieve their therapeutic effects by targeting specific genes, it is crucial to identify the proteins targeted by drugs and the genes implicated in diseases to facilitate successful drug repositioning. Consequently, simultaneous research has been conducted on drug–target interaction prediction and disease–gene prioritization methods to complement drug repositioning efforts.
In this study, we introduced a novel model that integrates GTD and MLP to identify triple associations among drugs, genes, and diseases. Our approach combines ID embedding vectors for drugs, genes, and diseases with biological similarities to facilitate learning. Through extensive experiments, we demonstrated that our proposed ensemble model surpassed the traditional tensor decomposition method in accurately predicting triple associations. This improvement can be attributed to the combination of GTD, which models drug–gene–disease associations, and MLP, which learns the individual features of drugs, genes, and diseases. As a result, our model captured complex associations among drugs, genes, and diseases more effectively than conventional element-wise multiplication in tensor decomposition.
Moreover, we leveraged the latent vectors for drugs, genes, and diseases obtained from the drug–gene–disease association prediction experiments to extend our approach for predicting drug–disease, drug–gene, and disease–gene associations. The proposed ensemble model consistently demonstrated superior performance in pairwise association predictions. Notably, previous methods that incorporated features from all three components, drugs, genes, and diseases, also yielded accurate results. These findings highlight the interactions among drugs, genes, and diseases, emphasizing the importance of considering genes in drug repositioning, diseases in DTI prediction, and drugs in disease-causing gene prioritization. Additionally, our proposed model enables the simultaneous prediction of drug–disease, drug–gene, and disease–gene associations through drug–gene–disease association prediction. Consequently, our ensemble model achieved fast performance in these tasks compared with existing methods that predict each type of pairwise association separately or the conventional tensor decomposition approach, which requires learning from large tensors.
This study has significant implications for the field of medical science. Possible implications include not only expanding the range of treatment for diseases but also identifying novel drug targets and disease mechanisms. Genetic information regarding therapeutic targets for drug repositioning can greatly contribute to personalized medicine by tailoring treatments based on an individual’s genetic makeup, thus minimizing adverse drug reactions and maximizing therapeutic efficacy. Moreover, leveraging genetic information allows for the assessment of disease risks and the implementation of preventive measures for specific conditions. Ultimately, these advancements will enable the development of more targeted and effective healthcare approaches.

Author Contributions

Conceptualization, Y.-R.C.; methodology, Y.K.; resources, Y.K.; software, Y.K.; data curation, Y.K.; formal analysis, Y.K. and Y.-R.C.; writing—original draft preparation, Y.K.; writing—review and editing, Y.-R.C.; supervision, Y.-R.C.; project administration, Y.-R.C.; funding acquisition, Y.-R.C. All authors have read and agreed to the published version of the manuscript.

Funding

This research was supported by the National Research Foundation of Korea (NRF) grant funded by the Ministry of Science and ICT (No. 2021R1A2C101194613), and Regional Innovation Strategy (RIS) through the National Research Foundation of Korea (NRF) funded by the Ministry of Education (MOE) in 2023 (2022RIS-005).

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

https://ads.yonsei.ac.kr/Ensemble/ (accessed on 15 June 2023).

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Pushpakom, S.; Iorio, F.; Eyers, P.A.; Escott, K.J.; Hopper, S.; Wells, A.; Doig, A.; Guilliams, T.; Latimer, J.; McNamee, C.; et al. Drug repurposing: Progress, challenges and recommendations. Nat. Rev. Drug Discov. 2019, 18, 41–58. [Google Scholar] [CrossRef]
  2. Shim, J.S.; Liu, J.O. Recent advances in drug repositioning for the discovery of new anticancer drugs. Int. J. Biol. Sci. 2014, 10, 654–663. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  3. Ding, H.; Takigawa, I.; Mamitsuka, H.; Zhu, S. Similarity-based machine learning methods for predicting drug–target interactions: A brief review. Brief. Bioinform. 2014, 15, 734–747. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  4. Shahreza, M.L.; Ghadiri, N.; Mousavi, S.R.; Varshosaz, J.; Green, J.R. A review of network-based approaches to drug repositioning. Brief. Bioinform. 2018, 19, 878–892. [Google Scholar] [CrossRef] [PubMed]
  5. Jung, Y.-S.; Kim, Y.; Cho, Y.-R. Comparative analysis of network-based approaches and machine learning algorithms for predicting drug–target interactions. Methods 2022, 198, 19–31. [Google Scholar] [CrossRef]
  6. Hopkins, A.L. Network pharmacology: The next paradigm in drug discovery. Nat. Chem. Biol. 2008, 4, 682–690. [Google Scholar] [CrossRef]
  7. Yildirim, M.A.; Goh, K.-I.; Cusick, M.E.; Barabasi, A.-L.; Vidal, M. Drug–target network. Nat. Biotechnol. 2007, 25, 1119–1126. [Google Scholar] [CrossRef]
  8. Yamanishi, Y.; Araki, M.; Gutteridge, A.; Honda, W.; Kanehisa, M. Prediction of drug–target interaction networks from the integration of chemical and genomic spaces. Bioinformatics 2008, 24, i232–i240. [Google Scholar] [CrossRef] [Green Version]
  9. Mei, J.-P.; Kwoh, C.-K.; Yang, P.; Li, X.-L.; Zheng, J. Drug–target interaction prediction by learning from local information and neighbors. Bioinformatics 2013, 29, 238–245. [Google Scholar] [CrossRef] [Green Version]
  10. Van Laarhoven, T.; Marchiori, E. Predicting drug–target interactions for new drug compounds using a weighted nearest neighbor profile. PLoS ONE 2013, 8, e66952. [Google Scholar] [CrossRef]
  11. Xia, Z.; Wu, L.-Y.; Zhou, X.; Wong, S.T.C. Semi-supervised drug-protein interaction prediction from heterogeneous biological spaces. BMC Syst. Biol. 2010, 4, 56. [Google Scholar] [CrossRef] [Green Version]
  12. Zheng, X.; Ding, H.; Mamitsuka, H.; Zhu, S. Collaborative matrix factorization with multiple similarities for predicting drug–target interactions. In Proceedings of the 19th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, Chicago, IL, USA, 11–14 August 2013; pp. 1025–1033. [Google Scholar]
  13. Peska, L.; Buza, K.; Koller, J. Drug–target interaction prediction: A Bayesian ranking approach. Comput. Methods Programs Biomed. 2017, 152, 15–21. [Google Scholar] [CrossRef]
  14. Luo, Y.; Zhao, X.; Zhou, J.; Yang, J.; Zhang, Y.; Kuang, W.; Peng, J.; Chen, L.; Zeng, J. A network integration approach for drug–target interaction prediction and computational drug repositioning from heterogeneous information. Nat. Commun. 2017, 8, 573. [Google Scholar] [CrossRef] [Green Version]
  15. Wan, F.; Hong, L.; Xiao, A.; Jiang, T.; Zeng, J. NeoDTI: Neural integration of neighbor information from a heterogeneous network for discovering new drug–target interactions. Bioinformatics 2019, 35, 104–111. [Google Scholar] [CrossRef]
  16. Zeng, X.; Zhu, S.; Lu, W.; Liu, Z.; Huang, J.; Zhou, Y.; Fang, J.; Huang, Y.; Guo, H.; Li, L.; et al. Target identification among known drugs by deep learning from heterogeneous networks. Chem. Sci. 2020, 11, 1775. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  17. Barabasi, A.-L.; Gulbahce, N.; Loscalzo, J. Network medicine: A network-based approach to human disease. Nat. Rev. Genet. 2011, 12, 56–68. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  18. Ata, S.K.; Wu, M.; Fang, Y.; Ou-Yang, L.; Kwoh, C.K.; Li, X.-L. Recent advances in network-based methods for disease gene prediction. Brief. Bioinform. 2021, 22, bbaa303. [Google Scholar] [CrossRef] [PubMed]
  19. Kim, Y.; Park, J.-H.; Cho, Y.-R. Network-based approaches for disease–gene association prediction using protein-protein interaction networks. Int. J. Mol. Sci. 2022, 23, 7411. [Google Scholar] [CrossRef]
  20. Vanunu, O.; Magger, O.; Ruppin, E.; Shlomi, T.; Sharan, R. Associating genes and protein complexes with disease via network propagation. PLoS Comput. Biol. 2010, 6, e1000641. [Google Scholar] [CrossRef] [Green Version]
  21. Yang, K.; Wang, R.; Liu, G.; Shu, Z.; Wang, N.; Zhang, R.; Yu, J.; Chen, J.; Li, X.; Zhou, X. HerGePred: Heterogeneous network embedding representation for disease gene prediction. IEEE J. Biomed. Health Inform. 2019, 23, 1805–1815. [Google Scholar] [CrossRef]
  22. Kim, Y.; Jung, Y.-S.; Park, J.-H.; Kim, S.-J.; Cho, Y.-R. Drug–disease association prediction using heterogeneous networks for computational drug repositioning. Biomolecules 2022, 12, 1497. [Google Scholar] [CrossRef] [PubMed]
  23. Wang, W.; Yang, S.; Zhang, X.; Li, J. Drug repositioning by integrating target information through a heterogeneous network model. Bioinformatics 2014, 30, 2923–2930. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  24. Luo, H.; Wang, J.; Li, M.; Luo, J.; Peng, X.; Wu, F.-X.; Pan, Y. Drug repositioning based on comprehensive similarity measures and Bi-Random walk algorithm. Bioinformatics 2016, 32, 2664–2671. [Google Scholar] [CrossRef] [Green Version]
  25. Wang, Y.; Guo, M.; Ren, Y.; Jia, L.; Yu, G. Drug repositioning based on individual bi-random walks on a heterogeneous network. BMC Bioinform. 2019, 20, 547. [Google Scholar] [CrossRef]
  26. Zeng, X.; Zhu, S.; Liu, X.; Zhou, Y.; Nussinov, R.; Cheng, F. deepDR: A network-based deep learning approach to in silico drug repositioning. Bioinformatics 2019, 35, 5191–5198. [Google Scholar] [CrossRef]
  27. Yang, X.; Zamit, L.; Liu, Y.; He, J. Additional neural matrix factorization model for computational drug repositioning. BMC Bioinform. 2019, 20, 423. [Google Scholar] [CrossRef] [Green Version]
  28. Yang, M.; Wu, G.; Zhao, Q.; Li, Y.; Wang, J. Computational drug repositioning based on multi-similarities bilinear matrix factorization. Brief. Bioinform. 2021, 22, bbaa267. [Google Scholar] [CrossRef]
  29. Sadeghi, S.; Lu, J.; Ngom, A. A network-based drug repurposing method via non-negative matrix factorization. Bioinformatics 2022, 38, 1369–1377. [Google Scholar] [CrossRef]
  30. Meng, Y.; Jin, M.; Tang, X.; Xu, J. Drug repositioning based on similarity constrained probabilistic matrix factorization: COVID-19 as a case study. Appl. Soft Comput. 2021, 103, 107135. [Google Scholar] [CrossRef]
  31. Yang, M.; Luo, H.; Li, Y.; Wu, F.-X.; Wang, J. Overlap matrix completion for predicting drug-associated indications. PLoS Comput. Biol. 2019, 15, e1007541. [Google Scholar] [CrossRef] [Green Version]
  32. Kolda, T.G.; Bader, B.W. TensorDecompositionsand Applications. SIAM Rev. 2009, 51, 455–500. [Google Scholar] [CrossRef] [Green Version]
  33. Wang, R.; Li, S.; Cheng, L.; Wong, M.H.; Leung, K.S. Predicting associations among drugs, targets and diseases by tensor decomposition for drug repositioning. BMC Bioinform. 2019, 20, 628. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  34. Jamali, A.A.; Tan, Y.; Kusalik, A.; Wu, F.-X. NTD-DR: Nonnegative tensor decomposition for drug repositioning. PLoS ONE 2022, 17, e0270852. [Google Scholar] [CrossRef] [PubMed]
  35. Huang, F.; Yue, X.; Xiong, Z.; Yu, Z.; Liu, S.; Zhang, W. Tensor decomposition with relational constraints for predicting multiple types of microRNA-disease associations. Brief. Bioinform. 2021, 22, bbaa140. [Google Scholar] [CrossRef]
  36. Kiers, H.A.L. Towards a standardized notation and terminology in multiway analysis. J. Chemom. 2000, 14, 105–122. [Google Scholar] [CrossRef]
  37. He, X.; Liao, L.; Zhang, H.; Nie, L.; Hu, X.; Chua, T.-S. Neural collaborative filtering. In Proceedings of the 26th International Conference on World Wide Web (WWW), Perth, WA, Australia, 3–7 April 2017; pp. 173–182. [Google Scholar]
  38. Gottlieb, A.; Stein, G.Y.; Ruppin, E.; Sharan, R. PREDICT: A method for inferring novel drug indications with application to personalized medicine. Mol. Syst. Biol. 2011, 7, 496. [Google Scholar] [CrossRef]
  39. Martinez, V.; Navarro, C.; Cano, C.; Fajardo, W.; Blanco, A. DrugNet: Network-based drug–disease prioritization by integrating heterogeneous data. Artif. Intell. Med. 2015, 63, 41–49. [Google Scholar] [CrossRef]
  40. Wishart, D.S.; Feunang, Y.D.; Guo, A.C.; Lo, E.J.; Marcu, A.; Grant, J.R.; Sajed, T.; Johnson, D.; Li, C.; Sayeeda, Z.; et al. DrugBank 5.0: A major update to the DrugBank database for 2018. Nucleic Acids Res. 2018, 46, D1074–D1082. [Google Scholar] [CrossRef]
  41. Amberger, J.S.; Bocchini, C.A.; Scott, A.F.; Hamosh, A. OMIM.org: Leveraging knowledge across phenotype-gene relationships. Nucleic Acids Res. 2019, 47, D1038–D1043. [Google Scholar] [CrossRef] [Green Version]
  42. Davis, A.P.; Grondin, C.J.; Johnson, R.J.; Sciaky, D.; Wiegers, J.; Wiegers, T.C.; Mattingly, C.J. Comparative Toxicogenomics Database (CTD): Update 2021. Nucleic Acids Res. 2021, 49, D1138–D1143. [Google Scholar] [CrossRef]
  43. Olson, T.; Singh, R. Predicting anatomic therapeutic chemical classification codes using tiered learning. BMC Bioinform. 2017, 18, 266. [Google Scholar] [CrossRef] [Green Version]
  44. Weininger, D. SMILES, a chemical language and information system. 1. Introduction to methodology and encoding rules. J. Chem. Inf. Comput. Sci. 1998, 28, 31–36. [Google Scholar] [CrossRef]
  45. Steinbeck, C.; Han, Y.; Kuhn, S.; Horlacher, O.; Luttmann, E.; Willighagen, E. The Chemistry Development Kit (CDK): An open-source Java library for chemo- and bioinformatics. J. Chem. Inf. Comput. Sci. 2003, 43, 493–500. [Google Scholar] [CrossRef] [Green Version]
  46. Cheng, F.; Kovács, I.A.; Barabási, A.-L. Network-based prediction of drug combinations. Nat. Commun. 2019, 10, 1197. [Google Scholar] [CrossRef] [Green Version]
  47. The Gene Ontology Consortium. The Gene Ontology resource: Enriching a GOld mine. Nucleic Acids Res. 2021, 49, D325–D334. [Google Scholar] [CrossRef]
  48. Pesquita, C.; Faria, D.; Falcao, A.O.; Lord, P.; Couto, F.M. Semantic similarity in biomedical ontologies. PLoS Comput. Biol. 2009, 5, e1000443. [Google Scholar] [CrossRef] [PubMed]
  49. Oughtred, R.; Rust, J.; Chang, C.; Breitkreutz, B.-J.; Stark, C.; Willems, A.; Boucher, L.; Leung, G.; Kolas, N.; Zhang, F.; et al. The BioGRID database: A comprehensive biomedical resource of curated protein, genetic, and chemical interactions. Protein Sci. 2021, 30, 187–200. [Google Scholar] [CrossRef]
  50. Kohler, S.; Gargano, M.; Matentzoglu, L.; Carmody, L.C.; Lewis-Smith, D.; Vasilevsky, N.A.; Danis, D.; Balagura, G.; Baynam, G.; Brower, A.N.; et al. The Human Phenotype Ontology in 2021. Nucleic Acids Res. 2021, 49, D1207–D1217. [Google Scholar] [CrossRef]
  51. Wakap, S.N.; Lambert, D.M.; Olry, A.; Rodwell, C.; Gueydan, C.; Lanneau, V.; Murphy, D.; Le Cam, Y.; Rath, A. Estimating cumulative point prevalence of rare diseases: Analysis of the Orphanet database. Eur. J. Hum. Genet. 2009, 28, 165–173. [Google Scholar] [CrossRef] [Green Version]
  52. Bragin, E.; Chatzimichali, E.A.; Wright, C.F.; Hurles, M.E.; Firth, H.V.; Bevan, A.P.; Swaminathan, G.J. DECIPHER: Database for the interpretation of phenotype-linked plausibly pathogenic sequence and copy-number variation. Nucleic Acids Res. 2014, 42, D993–D1000. [Google Scholar] [CrossRef]
Figure 1. ROC curves of drug–gene–disease triple association prediction experiments on the drug side using the networks based on (a) chemical structures and (b) ATC codes of drugs.
Figure 1. ROC curves of drug–gene–disease triple association prediction experiments on the drug side using the networks based on (a) chemical structures and (b) ATC codes of drugs.
Biomedicines 11 01998 g001
Figure 2. ROC curves of drug–gene–disease triple association prediction experiments on the disease side using the networks based on (a) chemical structures and (b) ATC codes of drugs.
Figure 2. ROC curves of drug–gene–disease triple association prediction experiments on the disease side using the networks based on (a) chemical structures and (b) ATC codes of drugs.
Biomedicines 11 01998 g002
Figure 3. AUC changes with respect to the rank for the prediction of drug–gene–disease triple associations using the networks based on chemical structures in (a,b), using the networks based on ATC codes in (c,d), on the drug side in (a,c), and on the disease side in (b,d).
Figure 3. AUC changes with respect to the rank for the prediction of drug–gene–disease triple associations using the networks based on chemical structures in (a,b), using the networks based on ATC codes in (c,d), on the drug side in (a,c), and on the disease side in (b,d).
Biomedicines 11 01998 g003
Figure 4. AUC changes with respect to the proportion of negative samples to a positive for the prediction of drug–gene–disease triple associations using the networks based on (a) chemical structures and (b) ATC codes of drugs.
Figure 4. AUC changes with respect to the proportion of negative samples to a positive for the prediction of drug–gene–disease triple associations using the networks based on (a) chemical structures and (b) ATC codes of drugs.
Biomedicines 11 01998 g004
Table 1. Number of nodes and edges in the drug, gene, and disease similarity networks.
Table 1. Number of nodes and edges in the drug, gene, and disease similarity networks.
Number of NodesNumber of Edges
Drug networkchemical structures659216,308
ATC codes636161,332
Disease network 782480,849
Gene network 28518,392
Table 2. Number of nodes and edges of drug–disease, drug–gene, and disease–gene pairwise associations to create drug–gene–disease tensors based on two distinct drug features, chemical structures, and ATC codes.
Table 2. Number of nodes and edges of drug–disease, drug–gene, and disease–gene pairwise associations to create drug–gene–disease tensors based on two distinct drug features, chemical structures, and ATC codes.
Number ofNumber ofNumber ofNumber of
DrugsGenesDiseasesAssociations
Chemical structuresdrug–disease615-2851728
drug–gene4527824-137,054
disease–gene-168290361
ATC codesdrug–disease593-2821681
drug–gene4387824-134,481
disease–gene-168290361
Table 3. Accuracy of predicting drug–gene–disease triple associations on the drug side.
Table 3. Accuracy of predicting drug–gene–disease triple associations on the drug side.
MethodNetworks Constructed by Chemical StructuresNetworks Constructed by ATC Codes
AUCNDCG@1NDCG@3NDCG@5NDCG@10AUCNDCG@1NDCG@3NDCG@5NDCG@10
GTD0.8140.7370.8010.8280.8570.8990.7980.8410.8570.880
MLP0.8880.6320.6890.7230.7790.9500.8720.9050.9100.920
Ensemble0.9600.9050.9210.9400.9450.9590.9360.9460.9510.960
NTD-DR0.8870.8530.9140.9280.9300.9180.8940.9180.9410.943
Table 4. Accuracy of predicting drug–gene–disease triple associations on the disease side.
Table 4. Accuracy of predicting drug–gene–disease triple associations on the disease side.
MethodNetworks Constructed by Chemical StructuresNetworks Constructed by ATC Codes
AUCNDCG@1NDCG@3NDCG@5NDCG@10AUCNDCG@1NDCG@3NDCG@5NDCG@10
GTD0.8860.6560.7530.7680.8050.8910.7870.8420.8620.882
MLP0.9120.8690.8700.8690.8830.8710.9020.9040.9120.918
Ensemble0.9470.8690.8860.9110.9220.8950.9180.9210.9330.947
NTD-DR0.9410.7050.8000.8170.8250.9340.7700.8490.8420.857
Table 5. Accuracy of predicting drug–disease pairwise associations on the drug side.
Table 5. Accuracy of predicting drug–disease pairwise associations on the drug side.
MethodNetworks Constructed by Chemical StructuresNetworks Constructed by ATC Codes
AUCNDCG@1NDCG@3NDCG@5NDCG@10AUCNDCG@1NDCG@3NDCG@5NDCG@10
GTD0.7660.3050.4240.5170.6060.8540.4150.5380.6080.663
MLP0.8120.3160.4380.4910.5980.8480.4260.5860.6430.710
Ensemble0.8350.3790.5460.6030.6690.8740.5000.6430.7020.756
MBiRW0.7070.2380.4000.4780.5390.8670.5680.6990.7400.788
MSBMF0.7150.2900.4600.5210.5730.8230.5300.6850.7030.756
OMC0.8060.3840.5640.6090.6650.9020.5920.7340.7690.806
deepDR0.6620.0380.0390.0980.1950.5650.1710.2670.3100.415
Table 6. Accuracy of predicting drug–gene pairwise associations on the drug side.
Table 6. Accuracy of predicting drug–gene pairwise associations on the drug side.
MethodNetworks Constructed by Chemical StructuresNetworks Constructed by ATC Codes
AUCNDCG@1NDCG@3NDCG@5NDCG@10AUCNDCG@1NDCG@3NDCG@5NDCG@10
GTD0.5950.7470.7920.8030.8180.6520.9040.9020.8830.896
MLP0.5800.7680.7810.7860.8160.6530.8940.8810.8730.880
Ensemble0.6190.7790.7960.8090.8280.6810.9260.9180.9010.904
NetLapRLS0.6100.4910.7210.7960.8780.7090.5010.7300.8100.889
BLM-NII0.5670.3200.4980.5780.7350.5140.3450.5180.6180.760
MSCMF0.6130.3040.4220.4850.6900.5170.2830.3980.5020.688
Table 7. Accuracy of predicting disease–gene pairwise associations on the disease side.
Table 7. Accuracy of predicting disease–gene pairwise associations on the disease side.
MethodNetworks Constructed by Chemical StructuresNetworks Constructed by ATC Codes
AUCNDCG@1NDCG@3NDCG@5NDCG@10AUCNDCG@1NDCG@3NDCG@5NDCG@10
GTD0.8840.6560.7760.8070.8440.8790.5570.7080.7480.778
MLP0.8940.8690.8820.8930.9080.7930.8520.8710.8860.894
Ensemble0.9260.8520.8840.9050.9190.9240.8690.9120.9170.924
PRINCE0.6330.3630.4970.5810.7040.6370.3710.4930.5670.703
HerGePred0.6810.3300.5610.6310.7180.6770.3930.5670.6420.741
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Kim, Y.; Cho, Y.-R. Predicting Drug–Gene–Disease Associations by Tensor Decomposition for Network-Based Computational Drug Repositioning. Biomedicines 2023, 11, 1998. https://doi.org/10.3390/biomedicines11071998

AMA Style

Kim Y, Cho Y-R. Predicting Drug–Gene–Disease Associations by Tensor Decomposition for Network-Based Computational Drug Repositioning. Biomedicines. 2023; 11(7):1998. https://doi.org/10.3390/biomedicines11071998

Chicago/Turabian Style

Kim, Yoonbee, and Young-Rae Cho. 2023. "Predicting Drug–Gene–Disease Associations by Tensor Decomposition for Network-Based Computational Drug Repositioning" Biomedicines 11, no. 7: 1998. https://doi.org/10.3390/biomedicines11071998

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop