Browse code

Vignette syntax optimizations

balomenos authored on 29/09/2017 01:06:06
Showing 3 changed files

... ...
@@ -1,5 +1,5 @@
1 1
 Package: DEsubs
2
-Version: 1.3.3
2
+Version: 1.3.4
3 3
 Date: 2017-07-23
4 4
 Title: DEsubs: an R package for flexible identification of
5 5
         differentially expressed subpathways using RNA-seq expression
... ...
@@ -1,3 +1,6 @@
1
+1.3.4:  - Fixing (persistent) inconsistencies between vignette output within
2
+			the package and the output in the landing page.
3
+
1 4
 1.3.3:  - Replaced kable tables with pure markdown syntax.
2 5
         - Placed external figure importing within chunks.
3 6
  
... ...
@@ -130,13 +130,13 @@ the package itself (see Table 3).
130 130
 
131 131
 
132 132
 Supported Labels              R command
133
+------------------            --------------------------------------------------
133 134
 Entrez                        'entrezgene'
134 135
 Ensemble                      'ensembl_gene_id', 'ensembl_transcript_id'
135 136
                               'ensembl_peptide_id'
136 137
 HGNC                          'hgnc_id', 'hgnc_symbol', 'hgnc_transcript_name'
137 138
 Refseq                        'refseq_mrna', 'refseq_peptide'
139
+------------------            -------------------------------------------------
138 140
 Table: Supported gene labels
139 141
 
140 142
 
... ...
@@ -285,35 +285,35 @@ significant DEGs of his own experiment. A short description for all GOI types
285 285
 along with the corresponding parameters are shown in Table 6. 
286 286
 
287 287
 
288
-Type                  Description                                           R command
288
+Type                   Description                                           R command
289
+---------------------- ----------------------------------------------------  -------------
289 290
 **Topological**
290
-Degree                Number of adjacent interactions of the gene           'degree'
291
-Betweenness           Number of shortest paths from all vertices to all     'betweenness'
292
-                      others that pass through that node
293
-Closeness             Inverse of farness, which is the sum of distances     'closeness'
294
-                      to all other nodes
295
-Hub score             Kleinbergs hub centrality score                       'hub_score'
296
-Eccentricity          Shortest path distance from the farthest              'eccentricity'
297
-                      node in the graph
298
-Page rank             Google Page Rank                                      'page_rank'
299
-Start Nodes           Nodes without any incoming links                      'start_nodes'
291
+Degree                 Number of adjacent interactions of the gene           'degree'
292
+Betweenness            Number of shortest paths from all vertices to all     'betweenness'
293
+                       others that pass through that node
294
+Closeness              Inverse of farness, which is the sum of distances     'closeness'
295
+                       to all other nodes
296
+Hub score              Kleinbergs hub centrality score                       'hub_score'
297
+Eccentricity           Shortest path distance from the farthest              'eccentricity'
298
+                       node in the graph
299
+Page rank              Google Page Rank                                      'page_rank'
300
+Start Nodes            Nodes without any incoming links                      'start_nodes'
300 301
 **Functional**
301
-DEG                   Genes highly differentially expressed                 'deg'
302
-                      according to the experimental data
303
-Pathways              Genes acting as bridges among KEGG pathways           'KEGG'
304
-Biological Process    Genes acting as bridges among                         'GO_bp'
305
-                      Gene Ontology Biological Process terms
306
-Cellular Component    Genes acting as bridges among                         'GO_cc'
307
-                      Gene Ontology Cellular Component terms
308
-Molecular Function    Genes acting as bridges among                         'GO_mf'
309
-                      Gene Ontology Molecular Function terms
310
-Disease               Genes acting as bridges for OMIM targets              'Disease_OMIM'
311
-Disease               Genes acting as bridges for GAD targets               'Disease_GAD'
312
-Drug                  Genes acting as bridges for DrugBank targets          'Drug_DrugBank'
313
-microRNA              Genes acting as bridges for microRNA targets          'miRNA'
314
-Transcription Factors Genes acting as bridges for TF targets                'TF'
302
+DEG                    Genes highly differentially expressed                 'deg'
303
+                       according to the experimental data
304
+Pathways               Genes acting as bridges among KEGG pathways           'KEGG'
305
+Biological Process     Genes acting as bridges among                         'GO_bp'
306
+                       Gene Ontology Biological Process terms
307
+Cellular Component     Genes acting as bridges among                         'GO_cc'
308
+                       Gene Ontology Cellular Component terms
309
+Molecular Function     Genes acting as bridges among                         'GO_mf'
310
+                       Gene Ontology Molecular Function terms
311
+Disease                Genes acting as bridges for OMIM targets              'Disease_OMIM'
312
+Disease                Genes acting as bridges for GAD targets               'Disease_GAD'
313
+Drug                   Genes acting as bridges for DrugBank targets          'Drug_DrugBank'
314
+microRNA               Genes acting as bridges for microRNA targets          'miRNA'
315
+Transcription Factors  Genes acting as bridges for TF targets                'TF'
316
+---------------------- ----------------------------------------------------  -------------
315 317
 Table: Gene of interest (GOI) types
316 318
 
317 319
 
... ...
@@ -455,43 +455,43 @@ roles within the network                        'fwd.cascade.functional.GO_mf'
455 455
                                                 'bwd.cascade.functional.TF'
456 456
                                                 'bwd.cascade.functional.KEGG'
457 457
                                                 'bwd.cascade.functional.DEG'
458
+----------------------------------------------- -----------------------------------------------
458 459
 Table: Subpathway Options - CASCADE
459 460
 
460 461
 
461 462
 
462
-Type               Description                            R parameter
463
-Random Walk         Community structures that minimize    'community.infomap'
464
-                    the expected description length of
465
-                    a random walker trajectory
466
-Modular             Community structures via a modularity 'community.louvain'
467
-                    measure and a hierarchical approach
468
-Walktraps           Densely connected subgraphs via       'community.walktrap'
469
-                    random walks
470
-Leading eigen       Densely connected subgraphs based     'community.leading_eigen'
471
-                    on the leading non-negative eigen-
472
-                    vector of the modularity matrix
473
-Betweeneess         Community structures detection        'community.edge_betweenness'
474
-                    via edge betweenness
475
-Greedy              Community structures via greedy       'community.fast_greedy'
476
-                    optimization of modularity
463
+Type          Description                                 R parameter
464
+------------- ------------------------------------------  -------------------------------------
465
+Random Walk    Community structures that minimize         'community.infomap'
466
+               the expected description length of
467
+               a random walker trajectory
468
+Modular        Community structures via a modularity      'community.louvain'
469
+               measure and a hierarchical approach
470
+Walktraps      Densely connected subgraphs via            'community.walktrap'
471
+               random walks
472
+Leading eigen  Densely connected subgraphs based          'community.leading_eigen'
473
+               on the leading non-negative eigen-
474
+               vector of the modularity matrix
475
+Betweeneess    Community structures detection             'community.edge_betweenness'
476
+               via edge betweenness
477
+Greedy         Community structures via greedy            'community.fast_greedy'
478
+               optimization of modularity
479
+------------- ------------------------------------------  -------------------------------------
477 480
 Table: Subpathway Options - COMMUNITY
478 481
 
479 482
 
480 483
 
481
-Type               Description                            R parameter
482
-Cliques            A subgraph where every two distinct    'component.3-cliques'
483
-                   vertices in the clique are adjacent    ...
484
+Type          Description                                 R parameter
485
+------------- ------------------------------------------  -------------------------------------- 
486
+Cliques       A subgraph where every two distinct         'component.3-cliques'
487
+              vertices in the clique are adjacent          ...
484 488
                                                           'component.9-cliques'
485
-K-core             A maximal subgraph in which each       'component.3-coreness'
486
-                   vertex has at least degree k           ...
489
+K-core        A maximal subgraph in which each            'component.3-coreness'
490
+              vertex has at least degree k                ...
487 491
                                                           'component.9-coreness'
488
-Max cliques       Largest of maximal cliques              'component.max_cliques'
489
-Components        All single components                   'component.decompose'
492
+Max cliques   Largest of maximal cliques                  'component.max_cliques'
493
+Components    All single components                       'component.decompose'
494
+------------- ------------------------------------------  -------------------------------------- 
490 495
 Table: Subpathway Options - COMPONENT
491 496
 
492 497
 
... ...
@@ -644,7 +644,7 @@ res <- geneVisualization(
644 644
             export='plot', verbose=FALSE)
645 645
 ```
646 646
 
647
-```{r, echo=FALSE, fig.width=6.2, fig.height=5.2, fig.cap=cap }
647
+```{r, echo=FALSE, fig.width=6.2, fig.height=5.2, fig.cap=cap, fig.pos='h', out.extra='' }
648 648
 
649 649
 cap <- 'Bars illustrate the genes with the highest Q-values.'
650 650
 
... ...
@@ -660,7 +660,7 @@ res <- geneVisualization(
660 660
 ```
661 661
 
662 662
 
663
-```{r, echo=FALSE, fig.width=7, fig.height=4, fig.cap=cap  }
663
+```{r, echo=FALSE, fig.width=7, fig.height=4, fig.align='center', fig.cap=cap  }
664 664
 
665 665
 cap <- 'Heat map represents the twelve genes with the highest values of 
666 666
 functional measures. The values are scaled and the red graduation indicates 
... ...
@@ -720,7 +720,7 @@ res <- subpathwayToGraph(
720 720
 ```
721 721
 
722 722
 
723
-```{r, echo=FALSE, fig.width=3.5, fig.height=3.5, fig.cap=cap }
723
+```{r, echo=FALSE, fig.width=3.5, fig.height=3.5, fig.align='center', fig.cap=cap, fig.pos='h', out.extra='' }
724 724
 
725 725
 library('DEsubs')
726 726
 load(system.file('extdata', 'data.RData', package='DEsubs'))
... ...
@@ -756,7 +756,7 @@ res <- subpathwayVisualization(
756 756
 
757 757
 ```
758 758
 
759
-```{r, echo=FALSE, fig.width=3.8, fig.height=3.8, fig.cap=cap }
759
+```{r, echo=FALSE, fig.width=3.8, fig.height=3.8, fig.align='center', fig.cap=cap }
760 760
 
761 761
 cap <- 'Circular Diagram shows the associations among genes including in a 
762 762
 subpathway and Gene Ontology terms where are enriched'
... ...
@@ -774,7 +774,7 @@ res <- subpathwayVisualization(
774 774
                     verbose=FALSE)
775 775
 ```
776 776
 
777
-```{r, echo=FALSE, fig.width=4.0, fig.height=4.0, fig.cap=cap }
777
+```{r, echo=FALSE, fig.width=4.0, fig.height=4.0, fig.align='center', fig.cap=cap }
778 778
 
779 779
 cap <- 'Circular Diagram shows the associations among genes included in a 
780 780
 subpathway and enriched Transcription Factors.'
... ...
@@ -808,7 +808,7 @@ res <- organismVisualization(
808 808
                     verbose=FALSE)
809 809
 ```
810 810
 
811
-```{r, echo=FALSE, fig.width=7.4, fig.height=6, fig.cap=cap}
811
+```{r, echo=FALSE, fig.width=7.4, fig.height=6, fig.align='center', fig.cap=cap, fig.pos='h', out.extra=''}
812 812
 
813 813
 cap <- 'Dot plot shows the enriched associations among experiment-specific 
814 814
 extracted subpathways and pathwaysfrom KEGG database.