Skip to main content
Advertisement
Browse Subject Areas
?

Click through the PLOS taxonomy to find articles in your field.

For more information about PLOS Subject Areas, click here.

  • Loading metrics

ONION: Functional Approach for Integration of Lipidomics and Transcriptomics Data

Abstract

To date, the massive quantity of data generated by high-throughput techniques has not yet met bioinformatics treatment required to make full use of it. This is partially due to a mismatch in experimental and analytical study design but primarily due to a lack of adequate analytical approaches. When integrating multiple data types e.g. transcriptomics and metabolomics, multidimensional statistical methods are currently the techniques of choice. Typical statistical approaches, such as canonical correlation analysis (CCA), that are applied to find associations between metabolites and genes are failing due to small numbers of observations (e.g. conditions, diet etc.) in comparison to data size (number of genes, metabolites). Modifications designed to cope with this issue are not ideal due to the need to add simulated data resulting in a lack of p-value computation or by pruning of variables hence losing potentially valid information. Instead, our approach makes use of verified or putative molecular interactions or functional association to guide analysis. The workflow includes dividing of data sets to reach the expected data structure, statistical analysis within groups and interpretation of results. By applying pathway and network analysis, data obtained by various platforms are grouped with moderate stringency to avoid functional bias. As a consequence CCA and other multivariate models can be applied to calculate robust statistics and provide easy to interpret associations between metabolites and genes to leverage understanding of metabolic response. Effective integration of lipidomics and transcriptomics is demonstrated on publically available murine nutrigenomics data sets. We are able to demonstrate that our approach improves detection of genes related to lipid metabolism, in comparison to applying statistics alone. This is measured by increased percentage of explained variance (95% vs. 75–80%) and by identifying new metabolite-gene associations related to lipid metabolism.

Introduction

In recent years, research is becoming increasingly focused on the widest possible inclusion of biological processes at the level of cells and tissues from one and multiple organisms (e.g. the effect of bacterial flora on human metabolic processes). The huge amounts of data produced with high-throughput techniques make the information and knowledge harvesting challenging for technical and interpretation reasons [1,2]. Integration of data on multiple levels gives the opportunity for filtering high quality molecular signals and unravels biological complexity in unprecedented way.

Multivariate statistics are often used to explain complex relationships in the data. Typically in e.g. clinical applications number of observations is larger than explained features. In the case of high-throughput data, thousands of variables (e.g. expression of multiple transcription variants) are matched with simultaneous low numbers of observations (specific conditions, biological replicates, time points). In this respect, modifications of classic methods are needed to circumvent technical issues or to improve the predictive performance, e.g. regulated Canonical Correlation Analysis (rCCA) [3] or sparse Partial Least Square regression (sPLS) [4] to name just few. The objective of these approaches is the reduction of variables, with the final set of variables included in the model narrowed down in a mathematically justified way (with specific assumptions). Application of the described methods in analysis of e.g. medical data, provides results which may be of major importance in drawing conclusions significant from the clinical viewpoint [5].

This paper presents a novel procedure to support interpretation of orchestrated changes in cellular metabolism and gene expression. Its main objective is to reduce initial data size by creating groups, providing molecular functions are known, in order to reach feasibility of statistical analyses. The functional constraints specified (e.g. ontology terms, molecular interactions) are weak to avoid skewing towards highly specific biological pathways. The presented methodology may be applied for various data sets, and for lipidomics and transcriptomics in particular. The applicability has been illustrated on the example of murine nutrigenomics data [6] by identification of important genes associated with lipid metabolism.

Materials and Methods

Lipidomics and transcriptomics integration workflow

The lipidomics and transcriptomics integration workflow is presented in Fig 1 to illustrate all necessary steps from raw data processing to functional interpretation. It comprises data preparation, identification of lipids and genes groups and statistical tests to find significant associations between genes and metabolites. The workflow prototype is implemented in bash and R and available at https://bitbucket.org/VHG-IG/onion. We do not intend to cover vast possibilities for data normalisation or calling differential expression and metabolite detection to name just a few. Although, we leave it to the user to apply the strategy most appropriate to a particular scenario, we would like to stress the need to provide standardized data annotations.

thumbnail
Fig 1. Workflow of metabolomics and transcriptomics data integration.

After preprocessing, transcriptomics and metabolomics data are used to divide data set into functional groups. CCA and PLS statistics are calculated for each group in question to find rankings of gene–small molecule associations. Subsequent validation and functional analysis (e.g. by overrepresentation tests) helps in biological interpretation of ranked results.

https://doi.org/10.1371/journal.pone.0128854.g001

Data pre-processing.

Data used for the analysis should meet the basic criteria of quality and be previously normalized with approaches appropriate to specific use cases. For instance we used LOESS regression implemented in agilp package [7] to normalize Agilent microarray data. Standardisation of nomenclature is based on Lipid Maps (http://www.lipidmaps.org/) and ChEBI (https://www.ebi.ac.uk/chebi/) in case of small molecules, and Ensembl (http://www.ensembl.org) or RefSeq (http://www.ncbi.nlm.nih.gov/refseq/) are resources to control proper mRNA variant naming. Correct handling of the naming scheme is crucial for tracking of heterogeneous data derived from multiple technological platforms and primary analysis software to deliver proper annotation standards for subsequent steps. Despite existence of data specific ontologies and annotation standards such as provided by Lipid Maps, multiple cases across scientific literature evidently show that these standards are not yet widely adopted. This results in molecules escaping automated handling and manual curation is required.

Functional groups of genes and lipids.

Initial sets of genes involved in metabolic processes of fatty acids and lipids were found by searching Reactome pathways. Reactome is developed as an international collaboration aiming at the widest and most coherent description of cellular pathways in multiple model species [8]. First, for a given list of small molecule ChEBI identifiers [9] we find reactions in which these molecules participate either as substrates or products. Then, the Ensembl gene identifiers [10] are translated to match the identifier type present in the analysed expression data. This step utilises BioMart (www.biomart.org) [11] available in R through the biomaRt library [12]. Next, a set of differentially expressed genes is used to build a query in the STRING database via the STRINGdb Bioconductor library [13] to find interacting proteins and associations between genes. We use topological analysis such as distance from the lipid metabolism genes, co-occurrence in directed circuits and hub detection to expand the initial list of genes often not directly associated with lipid functions. Evidences such as text mining results, protein-protein interactions and gene proximity are taken into consideration on the condition of high quality of information from at least one source. Topological analysis is made with igraph library [14]. At the end we obtain a broad list of potential interactions to be sifted later by statistical testing with two goals: to minimise potential bias towards well-characterised biochemical pathways and at the same time propose new putative links relevant for the specific study (tissue, conditions).

Testing significant associations.

Canonical Correlation (CCA) as well as regularized Canonical Correlation (rCCA) was applied for assessment of associations between two groups of variables: lipidomics (responses) and transcriptomics (predictors). Canonical correlation can be applied iteratively to identify a set of prediction variables explaining the largest range of variability of a set of responses. In addition, elimination of highly correlated variables is the condition for correct application of canonical analysis. That is why prior to the proper canonical analysis, variables correlated above a certain threshold (e.g. r>0.7) are temporarily removed from the analysed data sets.

Depending on the data structure, the relevant type of canonical analysis should be selected. Classical CCA cannot be applied to the entire data set due to its structure (110 transcriptomics and 41 lipidomics variables with only 40 observations), therefore this approach was used only for analysis within functional groups. We used CCA implemented in R package yacca [15]. To compare performance of both classic and regularized approaches we applied rCCA implemented in FRCC [16] for both groups and the undivided data set. For the interpretation we focus mainly on the canonical correlations between pairs of first two canonical variables (CV1 and CV2) and structural correlations (loadings) between data sets and their respective canonical variables.

Apart from the Canonical Analysis (CCA and rCCA), Partial Least Squares Analysis (PLS and sPLS) is also efficient for data integration and assessment of the relationship of two groups of variables [17]. The aim of PLS is to predict or analyse a set of dependent variables from a set of independent variables or predictors [18,19] based on calculation of latent variables (LV). PLS is used routinely in exploration analysis, to select convenient predictors and to identify deviated observations. The practical difference between application of canonical analysis and PLS consists mostly in different preliminary premises. In PLS, filtering of correlated dependent and independent variables and specific structure of the data are no longer required for technical reasons yet approaches to select variables like sPLS are used to improve prediction performance affected by the size of linear combinations. First latent variable (LV1) as well as loadings (regression coefficients) for LV1 were considered to interpret associations between genes and metabolites. On the other hand, unlike in CCA, loadings of individual variables obtained in PLS are less suitable to pinpoint contributions of individual observations when number of variables is much larger than samples [20].

Finally, in order to compare results obtained by different techniques we may compare rankings of genes or association pairs rather than actual statistics of individual methods. We are then testing the number of new hits that: 1) could not be identified by looking at separate data sets alone; and 2) share functions relevant from the standpoint of metabolic priors. Furthermore, functions not previously implicated in the biological context in question could indicate interesting candidates for elucidation of new connections between metabolites or genes.

Comparison with simulated data sets.

An important aspect of interpretation of results obtained for groups and the undivided data set is the randomness of group composition. To assess the robustness of results obtained for specific groups we tested whether the levels of correlation or percentage of explained variance could be obtained merely by chance (H0). We simulated data sets by drawing lipids and genes in the same proportions as in the group in question in order to provide comparable conditions. For each such group we applied CCA and PLS and reported the fraction of given variables explained (Aggregate Redundancy Coefficients) and the percentage of explained variance respectively. We repeated this procedure 1000 times and compared the value yielded by our workflow with the mean values for each of the randomized data sets, testing significance with a one-sample t-test.

Results and Discussion

Performance on grouped and undivided data

We demonstrate our approach on data from a murine nutrigenomics study [6] available via the mixOmics R package. The population comprises mice nurtured in five different diet regimes, with 40 individuals in total. Based on the analysis of hepatic samples (four biological replicates at three time points each) it comprises gene expression data of 120 selected genes potentially involved in lipid metabolism and concentrations of 21 fatty acids. The data required treatment to match current gene symbol (HUGO) and small molecule nomenclatures (ChEBI). In a few cases gene symbols were not mapped precisely and we worked with a set of 110 genes in total. See Complete lists of canonical variables (S1 Data) for a full list of mapped identifiers. As raw data is not available, other pre-processing steps were not needed. Groups are created starting from the primary division of fatty acids to saturated mono and polyunsaturated, through associations of genes from relevant pathways and finally by expansion of the groups by topological analysis of the STRING interactome. Group 4 consists of metabolites and genes not included in Groups 1–3.

Canonical analysis techniques are applied to the undivided data set as well as functional groups (Table 1). Although, available data sets are relatively small (110 genes and 21 lipids), they are still too large for given number of samples (40 points) in order to successfully apply classical canonical correlation and we supplemented it with rCCA. The analysis reveals associations that are weaker in the undivided data (CV1 = 0.89, CV2 = 0.78) than in any of the groups (Table 1). In addition rCCA is subject to shortcomings: simulations are required to increase the size of the data, with a consequent lack of statistical significance test. For comparison, PLS was applied for the functional groups and undivided data sets as well. Results revealed that using functional groups (in all groups except Group1) leads to improvement in finding significant associations measured by percentage of explained variance.

thumbnail
Table 1. Results of Canonical Correlation Analysis of murine nutrigenomics.

https://doi.org/10.1371/journal.pone.0128854.t001

Functional analysis of top ranked solutions can be used to directly compare methods using different metrics as PLS or CCA. We counted the number of new lipid/fatty acid–gene associations not originally given by interrogating the sets of biochemical reactions directly involving the fatty acids in question. At the same time we can test for bias caused by using knowledge in the initial group definition. In order to do that we looked at the top 10% of gene candidates selected by CCA or PLS and checked their presence in: reactions queried by lipids/fatty acids defining group assignment; Reactome knowledge base; and in all pathways involving lipids. We present these counts in Table 2 together with lists of significantly enriched pathways (Table 3). The first important observation is the presence of minimal bias in group 1 (2 genes) and group 2 (1 gene). These are the only genes coding proteins involved in biochemical reactions of lipids or regulated by fatty acids (PPARA) and were selected from within the Reactome knowledge base by metabolomics results. Interestingly, top candidates found in the full data set are less frequently associated with the broad category of lipid metabolism. Thanks to interactome based selection we were able to highlight genes involved in lipid metabolism that would have been missed if analysing the transcriptomics data alone. For each category (except the full data set) there is number of significantly enriched pathways that are interesting from the perspective of both metabolism and role of lipids in cellular processes such as the regulation of gene transcription. The list of top ranked genes and details of PLS loadings which the ranking was derived from are given in List of top genes (S1 Table).

thumbnail
Table 2. Top 10% ranked PLS results in respective categories/groups.

https://doi.org/10.1371/journal.pone.0128854.t002

thumbnail
Table 3. Pathways significantly enriched (FDR < 0.05) within groups of genes in top 10% ranked PLS results in respective categories/groups.

https://doi.org/10.1371/journal.pone.0128854.t003

The final consideration of this section is randomness of estimated associations. For each of the randomized groups (rg1, rg2, rg3 and rg4) we calculated the mean value of aggregated explained variability (CCA) and mean value of the percentage of explained variation (PLS). The results were compared with the values obtained with actual functional groups g1, g2, g3 and their complement g4. Results of PLS and CCA are concordant. The calculated aggregate variances and percentage of variance explained in each group are significantly different than in corresponding randomized groups (Fig 2) proving a lack of randomness in our results.

thumbnail
Fig 2. Comparison of randomized groups with (A) CCA and (B) PLS results.

(A) CCA: Aggregate variability explained for Y|X and X|Y (B) PLS: % of explained variance. All differences between respective groups are significant (p <0.05, one-sample t-test). All–undivided data set; g1, g2, g3 –functional groups; g4 –complement; Rg1, Rg2, Rg3, Rg4 –mean values in randomized groups

https://doi.org/10.1371/journal.pone.0128854.g002

Functional analysis

Canonical analysis provides information about the scope of the explained variation in sets of lipidomics data (Y) based on transcriptomics data (X) and vice versa. First the canonical variable is statistically significant and very high (>0.9) across groups 1–4 suggesting high strength of associations between respective fatty acids and gene products. For instance, in group 1 oleic acid (ChEBI: 16196) and palmitoleic acid (ChEBI: 28716) are highly associated with RARB (retinoic acid receptor, beta), PLTP (phospholipid transfer protein), NR1I2 (nuclear receptor subfamily 1, group I, member 2) and APOA1 (apolipoprotein A-I). As APOA1 is directly involved in metabolism of fatty acids, it is an obvious candidate. The remaining genes are interesting hits due to participation in processes regulating or dependent on fatty acid regulated transcription and would have been overlooked with a typical pathway analysis. RARB stimulates hepatic induction of fibroblast growth factor 21 to promote fatty acid oxidation [21], PLTP has impact on metabolism of high-density lipoproteins [22] and transports diacylglycerol, and other molecules closely related with fatty acids metabolism. NR1I2 is a transcription factor binding to retinoic acid receptor RXR-RAR required by PPARG, involved in transcription regulation of multiple metabolic enzymes also implicated in regulation of diet-dependent metabolic syndrome [23] and regulates cytochrome P450 (CYP3A4) key to lipid synthesis. Finally, two genes LPIN1 and FABP6 are highly correlated to NR1I2 and PLTP respectively. LPIN1 regulates synthesis of triglyceride [24] and FABP6 is a bile and fatty acid transporter [25]. Similarly, in groups 2 and 3, genes that have the highest share in a given canonical variable (and then canonical correlations) are significantly involved in the metabolism of fatty acids: RARB, APOA1 and NR1I2 are already mentioned above. PSMB10 (proteasome subunit, beta type 10) is one of the proteasome components. It was recently shown that proteasome inhibition treatment caused down-regulation of multiple lipid metabolism enzymes causing subsequent decrease of fatty acid synthesis [26]. Lipids from group 2 with the largest contribution to canonical variables are: icosapentaenoic acid (ChEBI: 28364), and hexaenoic acid (ChEBI: 28125) (Fig 3). Similarly, in group 3, in which genes: RARB, CPT1A, RXRA (together with highly correlated CYP27B1, LDLR, LPIN1, NOS2, PPARD, SCARB1, UCP2, UCP3 and WDR) and PSMB10 share the largest association to palmitic (ChEBI: 15756) and myristic acids (ChEBI: 28875). CPT1A (carnitine palmitoyltransferase 1a) catalyses the primary regulated step in overall mitochondrial fatty acid oxidation [27] and CYP27B1, as other cytochrome P450 subunits, is involved in steroids synthesis.

thumbnail
Fig 3. Graphical presentation of the first canonical correlation for each group (1–4).

Correlation structure is indicated by length of the bars extending toward the circumference (positive correlation) or toward the centre (negative correlations). The left semicircle lists the transcriptional variables (X) and the right semicircle lists the fatty acids variables (Y).

https://doi.org/10.1371/journal.pone.0128854.g003

Group 4 included genes not included in groups 1–3. Albeit, comparably high canonical variables are found also in this group, genes with the highest correlations have no known function dependent on or involved in lipid metabolism: FAT1 (FAT tumour suppressor homolog 1), PRG4 (proteoglycan 4), II2 (interleukin 2) suggesting spurious characterisation of these associations. Thus, groups 1 and group 4 vary by qualitative differences in biological interpretation of statistical result. In addition functional grouping finds genes having significantly higher impact on metabolites (higher redundancy) than in the case of undivided data AND allows best explanation of variability of Y by X. In group 1 Y|X redundancy is 0.85 (85% of variation in lipidomics data set is explained by transcriptomics data set) compared to 0.65 in group 4. The reverted relations are much weaker (from 0.10 to 0.35) due to an unbalanced number of genes and metabolites specific to the nutrigenomics data set in question (Table 4).

thumbnail
Table 4. The CCA and rCCA results for Groups 1–4 and undivided data set.

https://doi.org/10.1371/journal.pone.0128854.t004

The size of the undivided data set does not allow the calculation of CCA and only rCCA can be practically applied resulting in significantly lower correlations (for λ1 = 0.064, λ2 = 0.008) than in groups 1–4 (Table 4). Most importantly, due to the lack of significance test, the validity of associations can be questioned allowing only approximate ranking of solutions. This creates difficulty in interpreting relationships between the data X|Y and Y|X similar to that obtained in CCA. In addition, low weights of variables that constitute canonical correlations do not allow finding many associations of particular genes and fatty acids. The highest associations were found for the following genes: SSX2IP (synovial sarcoma, X breakpoint 2 interacting protein), THRSP (thyroid hormone responsive), LPIN1 (lipin 1) and CYP24A1 (cytochrome P450, family 24, subfamily A, polypeptide 1) with fatty acids: gondoic acid (ChEBI: 32425), (Z)-hexadec-7-enoic acid (35465), (ChEBI: icosatrienoic acid). The highest weight is assigned to SSX2IP that amongst the others plays a role in adherens junctions and cell adhesion [28] and is not related to fatty acid or lipid metabolism.

Discussion and Conclusions

The methods used in integration of biological data differently account for biological context and emphasise interpretation of individual data types. In some cases the relation between different levels are function-agnostic and the test probabilities obtained from independent experiments are used to determine ranks of the solutions [29,30] in the others multiple data types are synergistically merged together to develop models tailored to specific biological phenomena e.g. data-driven network contextualization to study functional states [31]. Statistical techniques like CCA or rCCA do not include the biological context of the analysed variables. Despite further modifications of underlying statistical models [32] the typical outcome is still not satisfactory and the results can be difficult to interpret.

Biological function is most often taken into account by including pathway and gene ontology analysis, e.g. for finding genes involved in metabolic processes [33] or to analyse expression changes [34]. Network analysis defines alternative paths between phenotypes (gene expressions) with genotypes, which are then compared in terms of optimum explanation of numerous possible perturbations (e.g. mutations) [35]. Thus, considering the fact that genes, proteins and other molecules do not operate autonomously but are mutually dependent in continuously changing processes, incorporating biological priors into the analysis is substantively justified.

Herein, we present a novel procedure that effectively applies multivariate statistics for large high-throughput data sets making use of molecular interaction networks to guide selection of variables. It is worth mentioning that multivariate statistics implemented specifically for omics-data integration are available and widely used, including R packages mixOmics [36]. We find our approach a valuable complement, because 1) it presents strategy for gradual analysis of all variables rather than excluding any variables a priori; 2) the number of observations and variables are balanced without modification of original matrix by adding or removing data to avoid matrix singularity. Application to murine nutrigenomics data reveals strong associations between genes and fatty acids including previously unreported links involved in lipid metabolism.

The main limitation of the approach is relying on strong biological priors, in the form of reliable molecular networks, to source functional relationship between entities. Albeit, the potential bias is small and is limited to initial sets of genes coding proteins acting directly on metabolites under study it requires attention to ensure that local network connectivity is sufficient. This can be controlled in practical use scenario by looking at sizes and numbers of groups generated relative to the initial data size. In addition, at this stage the workflow is only suited to study data of well-annotated species such as mice and human; in the future, we plan to extend the approach by testing limits of orthologous annotation to guide the data division into functional groups.

Supporting Information

S1 Data. Tabular data in Excel format.

Complete lists of canonical variables. Supplementary data set lists all canonical variables identified as well as highly correlated (>0.7) genes and metabolites excluded prior analysis. Each sheet corresponds to either metabolite or gene data of particular group.

https://doi.org/10.1371/journal.pone.0128854.s001

(XLSX)

S1 Table. Tabular data in Word format.

List of top genes. In addition to counts presented in Table 2 this supplementary table lists symbols of top 10% of genes according to PLS and CCA rankings.

https://doi.org/10.1371/journal.pone.0128854.s002

(DOCX)

Acknowledgments

This research was supported in part by PL-Grid Infrastructure and Klaster LifeScience Kraków.

Author Contributions

Conceived and designed the experiments: WJ. Analyzed the data: WJ MP. Contributed reagents/materials/analysis tools: WJ MP. Wrote the paper: WJ MP.

References

  1. 1. Merelli I, Pérez-Sánchez H, Gesing S, D’Agostino D (2014) Managing, Analysing and Integrating Big Data in medical bioinformatics: open problems and future perspectives. DownloadsHindawiCom 2014. Available: http://downloads.hindawi.com/journals/bmri/aip/134023.pdf.
  2. 2. Gomez-Cabrero D, Abugessaisa I, Maier D, Teschendorff A, Merkenschlager M, et al. (2014) Data integration in the era of omics: current and future challenges. BMC Syst Biol 8: I1. Available: http://www.biomedcentral.com/1752-0509/8/S2/I1. pmid:25521591
  3. 3. Lê Cao K-A, Martin PGP, Robert-Granié C, Besse P (2009) Sparse canonical methods for biological data integration: application to a cross-platform study. BMC Bioinformatics 10: 34. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2640358&tool=pmcentrez&rendertype=abstract. Accessed 2014 January 10. pmid:19171069
  4. 4. Witten DM, Tibshirani RJ (2009) Extensions of sparse canonical correlation analysis with applications to genomic data. Stat Appl Genet Mol Biol 8: Article28. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2861323&tool=pmcentrez&rendertype=abstract. Accessed 2014 February 24.
  5. 5. Li X, Gill R, Cooper NGF, Yoo JK, Datta S (2011) Modeling microRNA-mRNA interactions using PLS regression in human colon cancer. BMC Med Genomics 4: 44. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3123543&tool=pmcentrez&rendertype=abstract. Accessed 2014 February 24. pmid:21595958
  6. 6. Martin PGP, Guillou H, Lasserre F, Déjean S, Lan A, et al. (2007) Novel aspects of PPARalpha-mediated regulation of lipid and xenobiotic metabolism revealed through a nutrigenomic study. Hepatology 45: 767–777. Available: http://www.ncbi.nlm.nih.gov/pubmed/17326203. Accessed 2014 January 24. pmid:17326203
  7. 7. Chain B (2012) agilp: Agilent expression array processing package.
  8. 8. Croft D, O’Kelly G, Wu G, Haw R, Gillespie M, et al. (2011) Reactome: a database of reactions, pathways and biological processes. Nucleic Acids Res 39: D691–D697. pmid:21067998
  9. 9. Hastings J, de Matos P, Dekker A, Ennis M, Harsha B, et al. (2013) The ChEBI reference database and ontology for biologically relevant chemistry: enhancements for 2013. Nucleic Acids Res 41: D456–D463. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3531142&tool=pmcentrez&rendertype=abstract. Accessed 2014 January 26. pmid:23180789
  10. 10. Flicek P, Amode MR, Barrell D, Beal K, Billis K, et al. (2014) Ensembl 2014. Nucleic Acids Res 42: D749–D755. Available: http://www.ncbi.nlm.nih.gov/pubmed/24316576. Accessed 2014 January 23. pmid:24316576
  11. 11. Kasprzyk A (2011) BioMart: driving a paradigm change in biological data management. Database (Oxford) 2011: bar049. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3215098&tool=pmcentrez&rendertype=abstract. Accessed 2014 January 21. pmid:22083790
  12. 12. Durinck S, Spellman PT, Birney E, Huber W (2009) Mapping identifiers for the integration of genomic datasets with the R/Bioconductor package biomaRt. Nat Protoc 4: 1184–1191. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3159387&tool=pmcentrez&rendertype=abstract. Accessed 2014 February 21. pmid:19617889
  13. 13. Jensen LJ, Kuhn M, Stark M, Chaffron S, Creevey C, et al. (2009) STRING 8—a global view on proteins and their functional interactions in 630 organisms. Nucleic Acids Res 37: D412–D416. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2686466&tool=pmcentrez&rendertype=abstract. Accessed 2014 January 21. pmid:18940858
  14. 14. Csardi G, Nepusz T (2006) The igraph software package for complex network research. InterJournal Complex Sy: 1695. Available: http://igraph.org.
  15. 15. Butts CT (2012) yacca: Yet Another Canonical Correlation Analysis Package. Available: http://cran.r-project.org/package=yacca.
  16. 16. Cruz-Cano R (2012) FRCC: Fast Regularized Canonical Correlation Analysis. Available: http://cran.r-project.org/package=FRCC.
  17. 17. Cserháti T, Kósa A, Balogh S (1998) Comparison of partial least-square method and canonical correlation analysis in a quantitative structure–retention relationship study. J Biochem Biophys Methods 36: 131–141. Available: http://www.sciencedirect.com/science/article/pii/S0165022X98000086. Accessed 2014 March 13. pmid:9711499
  18. 18. Haaland DM, Thomas E V. (1988) Partial least-squares methods for spectral analyses. 1. Relation to other quantitative calibration methods and the extraction of qualitative information. Anal Chem 60: 1193–1202. Available: http://dx.doi.org/10.1021/ac00162a020. Accessed 2015 March 11.
  19. 19. Dong K, Zhang F, Zhu W, Wang Z, Wang G (2014) Partial least squares based gene expression analysis in posttraumatic stress disorder. Eur Rev Med Pharmacol Sci 18: 2306–2310. pmid:25219830
  20. 20. Chun H, Keleş S (2010) Sparse partial least squares regression for simultaneous dimension reduction and variable selection. J R Stat Soc Series B Stat Methodol 72: 3–25. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2810828&tool=pmcentrez&rendertype=abstract. pmid:20107611
  21. 21. Li Y, Wong K, Walsh K, Gao B, Zang M (2013) Retinoic acid receptor β stimulates hepatic induction of fibroblast growth factor 21 to promote fatty acid oxidation and control whole-body energy homeostasis in mice. J Biol Chem 288: 10490–10504. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3624431&tool=pmcentrez&rendertype=abstract. Accessed 2014 June 5. pmid:23430257
  22. 22. Jiang X-C, Jin W, Hussain MM (2012) The impact of phospholipid transfer protein (PLTP) on lipoprotein metabolism. Nutr Metab (Lond) 9: 75. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3495888&tool=pmcentrez&rendertype=abstract. Accessed 2014 June 9. pmid:22897926
  23. 23. Choi JH, Banks AS, Estall JL, Kajimura S, Boström P, et al. (2010) Anti-diabetic drugs inhibit obesity-linked phosphorylation of PPARγ by Cdk5. Nature 466: 451–456. Available: http://www.nature.com/doifinder/10.1038/nature09291. Accessed 2010 July 21. pmid:20651683
  24. 24. Kok BPC, Kienesberger PC, Dyck JRB, Brindley DN (2012) Relationship of glucose and oleate metabolism to cardiac function in lipin-1 deficient (fld) mice. J Lipid Res 53: 105–118. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3243467&tool=pmcentrez&rendertype=abstract. Accessed 2014 June 23. pmid:22058427
  25. 25. Zhang P, Takeuchi K, Csaki LS, Reue K (2012) Lipin-1 phosphatidic phosphatase activity modulates phosphatidate levels to promote peroxisome proliferator-activated receptor γ (PPARγ) gene expression during adipogenesis. J Biol Chem 287: 3485–3494. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3271002&tool=pmcentrez&rendertype=abstract. Accessed 2014 June 23. pmid:22157014
  26. 26. Oliva J, French SW, Li J, Bardag-Gorce F (2012) Proteasome inhibitor treatment reduced fatty acid, triacylglycerol and cholesterol synthesis. Exp Mol Pathol 93: 26–34. Available: http://www.ncbi.nlm.nih.gov/pubmed/22445925. Accessed 2014 June 9. pmid:22445925
  27. 27. Lee K, Kerner J, Hoppel CL (2011) Mitochondrial carnitine palmitoyltransferase 1a (CPT1a) is part of an outer membrane fatty acid transfer complex. J Biol Chem 286: 25655–25662. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3138250&tool=pmcentrez&rendertype=abstract. Accessed 2014 June 9. pmid:21622568
  28. 28. Breslin A, Denniss F, Guinn B (2007) SSX2IP: an emerging role in cancer. Biochem Biophys Res … 363: 462–465. Available: http://www.sciencedirect.com/science/article/pii/S0006291X07020426. Accessed 2014 July 25. pmid:17904521
  29. 29. Peterlin B, Maver a (2012) Integrative ‘omic’ approach towards understanding the nature of human diseases. Balkan J Med Genet 15: 45–50. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3776674&tool=pmcentrez&rendertype=abstract. pmid:24052743
  30. 30. Kaever A, Landesfeind M, Feussner K, Morgenstern B, Feussner I, et al. (2014) Meta-analysis of pathway enrichment: Combining independent and dependent omics data sets. PLoS One 9.
  31. 31. Crespo I, Roomp K, Jurkowski W, Kitano H, Del Sol A (2012) Gene regulatory network analysis supports inflammation as a key neurodegeneration process in prion disease. BMC Syst Biol 6: 132. Available: http://www.ncbi.nlm.nih.gov/pubmed/23068602. Accessed 2012 November 5. pmid:23068602
  32. 32. Chung D, Chun H, Keles S (2013) spls: Sparse Partial Least Squares (SPLS) Regression and Classification. Available: http://cran.r-project.org/package=spls.
  33. 33. Zhao C, Mao J, Ai J, Shenwu M, Shi T, et al. (2013) Integrated lipidomics and transcriptomic analysis of peripheral blood reveals significantly enriched pathways in type 2 diabetes mellitus. BMC Med Genomics 6 Suppl 1: S12. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3552685&tool=pmcentrez&rendertype=abstract. Accessed 2014 January 10. pmid:23369247
  34. 34. Wang X, Cairns MJ (2013) Gene set enrichment analysis of RNA-Seq data: integrating differential expression and splicing. BMC Bioinformatics 14 Suppl 5: S16. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3622641&tool=pmcentrez&rendertype=abstract. Accessed 2014 July 10. pmid:23734663
  35. 35. Gosline S, Spencer S, Ursu O, Fraenkel E (2012) SAMNet: a network-based approach to integrate multi-dimensional high throughput datasets. Integr Biol 246: 221–238. Available: http://pubs.rsc.org/en/content/articlehtml/2012/ib/c2ib20072d. Accessed 2014 January 26.
  36. 36. Lê Cao K-A, González I, Déjean S (2009) integrOmics: an R package to unravel relationships between two omics datasets. Bioinformatics 25: 2855–2856. Available: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2781751&tool=pmcentrez&rendertype=abstract. Accessed 2014 January 10. pmid:19706745