1 rnaCrosslinkOO

Please check out the publication if you interesting in this tool and the github.

2 The COMRADES experiment


The COMRADES experimental protocol for the prediction of RNA structure in vivo was first published in 2018 (Ziv et al., 2019) where they predicted the structure of the Zika virus. The protocol has subsequently been use to predict the structure of SARS-CoV-2 (Ziv et al., 2020). Have a look to get an understanding of the protocol:

  • COMRADES determines in vivo RNA structures and interactions. (2018). Omer Ziv, Marta Gabryelska, Aaron Lun, Luca Gebert. Jessica Sheu-Gruttadauria and Luke Meredith, Zhong-Yu Liu, Chun Kit Kwok, Cheng-Feng Qin, Ian MacRae, Ian Goodfellow , John Marioni, Grzegorz Kudla, Eric Miska. Nature Methods. Volume 15. https://doi.org/10.1038/s41592-018-0121-0

  • The Short- and Long-Range RNA-RNA Interactome of SARS-CoV-2. (2020). Omer Ziv, Jonathan Price, Lyudmila Shalamova, Tsveta Kamenova, Ian Goodfellow, Friedemann Weber, Eric A. Miska. Molecular Cell, Volume 80 https://doi.org/10.1016/j.molcel.2020.11.004

Figure from Ziv et al., 2020. Virus-inoculated cells are crosslinked using clickable psoralen. Viral RNA is pulled down from the cell lysate using an array of biotinylated DNA probes, following digestion of the DNA probes and fragmentation of the RNA. Biotin is attached to crosslinked RNA duplexes via click chemistry, enabling pulling down crosslinked RNA using streptavidin beads. Half of the RNA duplexes are proximity-ligated, following reversal of the crosslinking to enable sequencing. The other half serves as a control, in which crosslink reversal proceeds the proximity ligation
Figure from Ziv et al., 2020. Virus-inoculated cells are crosslinked using clickable psoralen. Viral RNA is pulled down from the cell lysate using an array of biotinylated DNA probes, following digestion of the DNA probes and fragmentation of the RNA. Biotin is attached to crosslinked RNA duplexes via click chemistry, enabling pulling down crosslinked RNA using streptavidin beads. Half of the RNA duplexes are proximity-ligated, following reversal of the crosslinking to enable sequencing. The other half serves as a control, in which crosslink reversal proceeds the proximity ligation

After sequencing, short reads are produced similar to a spliced / chimeric RNA read but where one half of the read corresponds to one half of a structural RNA duplex and the other half of the reads corresponds to the other half of the structural RNA duplex. This package has been designed to analyse this data. The short reads need to be prepared in a specific way to be inputted into this package.

There are other types of crosslinking data!


5 Slow Start

The package has 3 main processes; clustering, cluster trimming and folding. The next sections take you through the usage of each of these main stages.


rnacrosslinkOO

5.1 rnaCrosslinkQC

Before you make the object you can check the read sizes of the duplexes and the transcripts that exist within the dataset using the rnaCrosslinkQC method. This is the first port of call for the analysis.

rnaCrosslinkQC(sampleTable2,
               directory = ".", 
               topTranscripts = F)

Using the plot of read sizes you can choose the desired read size when creating the object. This affects the resolution of the data and the subsequent accuracy of the folding. The shorter the reads, the more accurate.It is highly recommended to choose a read size cutoff that is smaller than 60bp if you would like to do structural prediction.

Checking the output file topTranscripts_all.txt will allow you to see the top inter and intra RNA interactions in the dataset and grab the ID which you will need for creating the object.

5.2 Make the Object

The instance of the rnaCrosslinkDataSet object that is created stores the information from the experiment including raw and processed data for the dataset.

5.2.1 Slots / Attributes


5.2.1.0.1 Analysis stage

The slots for processed and unprocessed data keep the data from each stage of the analysis, this allows the user to quickly access any part of the results. Checking the status of the object will allow you to see which stages of the analysis are present for each of the attributes.

5.2.1.0.2 Meta-data
  • rnas - The RNA ID for this instance
  • rnaSize - The size in nuceloties of the RNA for this instance
  • sampleTable - The meta-data for the instance ( detailed above )


5.2.1.0.3 Raw-data and processed data
  • InputFiles - Data in the original input file format (list) InputFiles - rna ID - Analysis stage - Sample Name
  • matrixList - Data in contact matrix format (list) (cells contain the number of reads assinged to those interacting coordinates) InputFiles - rna ID - Analysis stage - Sample Name
  • clusterGrangesList - Granges of clusters identified (list) InputFiles - rna ID - Analysis stage - Sample Name
  • clusterTableList - Data frame of clusters identified (list) InputFiles - rna ID - Analysis stage - Sample Name
  • clusterTableFolded - A table of all clusters with predicted structures included
  • interactionTable - A table contraints predicted for folding
  • viennaStructures - A list of predicted structures in vienna format


5.2.2 rnaCrosslinkDataSet - make object

# load the object
cds = rnaCrosslinkDataSet(rnas = rna,
                      sampleTable = sampleTable2,
                      subset = "all",
                      sample = "all")
#>  ********************************************
#>  *****            rnaCrosslink-OO          ******
#>  ********************************************
#>  *****-------*******************-------******
#>  *****       Reading SampleTable       ******
#>  *****       Detected  2  Samples      ******
#>  *****     detected group c:: 2       *****
#>  *****     detected group s:: 1       *****
#>  ****      Sample Names:  s1 c1    ****  ****      Sample Names:  s1 c1    ****  ****      Sample Names:  s1 c1    ****  ****      Sample Names:  s1 c1    ****
#>  *****         Reading Input Files        *****
#>  *****  Checking Subsetting Options  *****
#>  *****  No user subsetting chosen  *****
#>  *****  Checking Sampling Options  *****
#>  *****  No user sampling chosen  *****
#>  *****     Getting RNAs of Interest    ******
#>  *****    RNA of interest + Host RNA    *****
#>  *****      RNA of interest Alone       *****
#>  *****         Making Matrices         ******
#>  *****          RNA Size:  1896         *****
#>  *****         Creating object          *****
#>  *****-------*******************-------******
#>  ******************************************** 
#>  ********************************************
# be aware there are extra options here
# including:
# subset - allows you to choose specific read sizes (this affects resolution and accuracy)
# sample - Choose the same ammount of reads for each sample (useful for comparisons)


5.3 Access the data within the instance

You can check on major parts of the object and return slots and other information using the accessor methods


5.3.1 General Acessors


5.3.1.1 Check Status of Instance

In each slot the analysis stages available to you are shown next to the slot name. These can be used in getData to extract the data for that slot and analysis type.

# Check status of instance 
cds
#> rnaCrosslinkDataSet Object 
#> RNAs Analysed                -              -  ENSG000000XXXXX_NR003286-2_RN18S1_rRNA 
#> Samples Analysed             -              -  s1 c1 
#> InputFiles           - Raw data               -  original host noHost 
#> matrixList         - Contact Matricies      -  noHost original 
#> clusterTableList   - Cluster positions      -  
#> clusterGrangesList - Granges of clusters    -  
#> interactionTable   - Predictied interaction -  0 
#> viennaStructures   - Predicted Structures   - 0


5.3.1.2 Retreive RNA Size

# Returns the size of the RNA
rnaSize(cds)
#> [1] 1896


5.3.1.3 Retreive Meta-data

# Returns the sample table 
sampleTable(cds)


5.3.1.4 Retreive Sample Groups

# Returns indexes of the samples in the control and not control groups
group(cds)
#> $c
#> [1] 2
#> 
#> $s
#> [1] 1


5.3.1.5 Retreive Sample Names

# Get the sample names of the instance
sampleNames(cds)
#> [1] "s1" "c1"


5.3.1.6 Retreive Data in original format

It is more recommended to use getData for this purpose but sometime is is useful to grab all data in the InputFiles slot which contains all raw and processed data in the original input format from each analysis stage that has been performed.

# Return the InputFiles slot
InputFiles(cds)


5.3.1.7 Retreive Contact Matrices

It is more recommended to use getData for this purpose but sometime is is useful to grab all data in the matrixList slot which contains contact matrices from each analysis stage that has been performed.

# Return the matrixList slot 
matrixList(cds) 


5.3.2 Get Data

Get data is more generic method for retrieving data from the object and returns a list, the number of entries in the list is number of samples in the dataset and the list contain entries of the data type and analysis stage you select.

data = getData(x    = cds,              # The object      
               data =  "InputFiles",       # The Type of data to return     
               type = "original")[[1]] # The stage of the analysis for the return data

head(data)


5.4 Check Interactions

The first step is to assess the species of RNA present in the dataset, the instance will probably contain inter-RNA interactions and intra-RNA interactions for many different RNAs. A number of tables showing the different RNAs / interactions and the ammount of reads assigned to each can be returned with the following methods:


5.4.1 topTranscripts

# Returns the RNAs with highest number of assigned reads 
# regardless of whether it is an Inter or Intra - RNA interaction. 
topTranscripts(cds,
               2)  # The number of entries to return


5.4.2 topInteractors

# Returns the RNAs that interact with the RNA of interest
topInteracters(cds, # The rnaCrosslinkDataSet instance
               1)   # The number of entries to return


5.4.3 topInteractions

# Returns the Interacions with the highest number of assigned reads
topInteractions(cds, # The rnaCrosslinkDataSet instance
                2)   # The number of entries to return


5.4.4 Get Count Matricies

features = featureInfo(cds) # The rnaCrosslinkDataSet instance



# Counts for features at the transcript level
features$transcript

# Counts for features at the family level (last field with  "_" delimited IDs)
features$family


5.5 Clustering

In the rnaCrosslink data, crosslinking and fragmentation leads to the production of redundant structural information, where the same in vivo structure from different RNA molecules produces slightly different RNA fragments. Clustering of these duplexes that originate from the same place in the reference transcript reduces computational time and allows trimming of these clusters to improve the folding prediction. To allow clustering, gapped alignments can be described by the transcript coordinates of the left (L) and right (R) side of the reads and by the nucleotides between L and R (g). Reads with similar or identical g values are likely to originate from the same structure of different molecules. In rnaCrosslink-OO, an adjacency matrix is created for all chimeric reads based on the nucleotide difference between their g values (Deltagap). This results in Deltagap = 0 for identically overlapping gaps and increasing Deltagap values for gapped reads with less overlap:

  • Deltagap(gi,gj) = max(width(gi),width(gj)) – widthofIntersection(gi,gj)

For short range interactions ( g <= 10 nt ) the weights are calculated such that the highest weights are given to exactly overlapping gapped alignments and a weight of 0 is assigned to alignments that do not overlap.

  • E(gi, gj) = 10 - Deltagap(gi, gj)

Long range interactions (g >10) are clustered separately and their weights are calculated as follows and edges with weights lower that 0 are set to 0. Meaning that gaps that do not overlap by at least 15 nucleotides are considered in different clusters.

  • E(gi, gj) = 15 - Deltagap(gi, gj)

From these weights the network can be defined for short- and long-range interaction as: G = (V, E). To identify clusters within the graph (subgraphs) the graph is clustered using random walks with the cluster_waltrap function (steps = 2) from the iGraph packageå, there is an option for users to remove clusters with less than a specified amount of reads. These clusters often contain a small number of longer L or R sequences due to the random fragmentation in the rnaCrosslink protocol.

# Cluster the reads
clusteredCds = clusterrnaCrosslink(cds = cds,     # The rnaCrosslinkDataSet instance 
                               cores = 1,         # The number of cores
                               stepCount = 2,     # The number of steps in the random walk
                               clusterCutoff = 2) # The minimum number of reads for a cluster to be considered
#> ********************************************
#> ****  ENSG000000XXXXX_NR003286-2_RN18S1_rRNA  *****
#> ****               1896  nt             ****
#> ****       Assessing Long Range         ****
#> ****        Sampling Long Range         ****
#> ****      Assessing Short Range         ****
#> ****      Sampling short Range          ****
#> *****        done  s1 1  / 1           *****
#> *****        done  c1 1  / 1           *****
#> *****          Creating object         *****
#> ********************************************
# Check status of instance 
clusteredCds
#> rnaCrosslinkDataSet Object 
#> RNAs Analysed                -              -  ENSG000000XXXXX_NR003286-2_RN18S1_rRNA 
#> Samples Analysed             -              -  s1 c1 
#> InputFiles           - Raw data               -  original host noHost 
#> matrixList         - Contact Matricies      -  noHost original originalClusters 
#> clusterTableList   - Cluster positions      -  original 
#> clusterGrangesList - Granges of clusters    -  original 
#> interactionTable   - Predictied interaction -  0 
#> viennaStructures   - Predicted Structures   - 0


5.5.1 Cluster Numbers

# Returns the number of clusters in each sample
clusterNumbers(clusteredCds)

5.5.2 Read numbers in clusters


# Returns the number reads in clusters
readNumbers( clusteredCds)

5.5.3 Cluster Tables


The cluster tables contain coordinates of the clusters in data.frame format. Each cluster has a unique ID and size.x corrasponds to the number of reads assigned to that cluster or supercluster. ls, le, rs and le give the coordinates of the interaction.

getData(clusteredCds,        # The object             
        "clusterTableList",  # The Type of data to return     
        "original")[[1]]     # The stage of the analysis for the return data

5.5.4 Cluster GRanges


You can also extract a GRanges object of the individual reads and their cluster membership:

getData(clusteredCds,         # The object        
        "clusterGrangesList", # The Type of data to return     
        "original")[[1]]      # The stage of the analysis for the return data

5.6 Cluster Trimming


Given the assumption that the reads within each cluster likely originate from the same structure in different molecules these clusters can be trimmed to contain the regions from L and R that have the most evidence the clustering and trimming is achieved with the clusterrnaCrosslink and trimClusters methods.

# Trim the Clusters
trimmedClusters = trimClusters(clusteredCds = clusteredCds, # The rnaCrosslinkDataSet instance 
                               trimFactor = 1,              # The cutoff for cluster trimming (see above)
                               clusterCutoff = 0)          # The minimum number of reads for a cluster to be considered
#> ********************************************
#> ******        Trimming Clusters       ******
#> ******            Saving              ******
#> ******        Saving mat list         ******
#> ******       Saving table list        ******
#> ******           Saving  End          ******
#> ******      Saving mat list  End      ******
#> ******     Saving granges list        ******
#> ******     Saving table list  End     ******
#> ********************************************
# Check status of instance 
trimmedClusters
#> rnaCrosslinkDataSet Object 
#> RNAs Analysed                -              -  ENSG000000XXXXX_NR003286-2_RN18S1_rRNA 
#> Samples Analysed             -              -  s1 c1 
#> InputFiles           - Raw data               -  original host noHost 
#> matrixList         - Contact Matricies      -  noHost original originalClusters superClusters trimmedClusters 
#> clusterTableList   - Cluster positions      -  original superClusters trimmedClusters 
#> clusterGrangesList - Granges of clusters    -  original superClusters trimmedClusters 
#> interactionTable   - Predictied interaction -  0 
#> viennaStructures   - Predicted Structures   - 0
# Returns the number of clusters in each sample
clusterNumbers(trimmedClusters)
# Returns the number reads in clusters
readNumbers( trimmedClusters)

see Plotting contact matrices

5.7 Check Cluster Agreement between replicates


#plotClusterAgreement(trimmedClusters,
#                     "trimmedClusters")
#plotClusterAgreementHeat(trimmedClusters,
#                         "trimmedClusters")

5.8 Folding


The final step is folding, this step populates the viennaStructures, dgs and interactionTable slots. This step can only be run if you have the Vienna package installed and RNAFold in your PATH.

# Fold the RNA in part of whole
foldedCds = foldrnaCrosslink(trimmedClusters,
                         rnaRefs = rnaRefs,
                         start = 1600,
                         end = 1869,
                         shape = 0,
                         ensembl = 20,
                         constraintNumber  = 30,
                         evCutoff = 5)
# Check status of instance 
foldedCds

6 Other Plots and Functionality

6.1 Plotting contact matrices


Plots can be made for each sample using the plotMatrices function.

# Plot heatmaps for each sample
#plotMatrices(cds = cds,         # The rnaCrosslinkDataSet instance 
#             type = "original", # The "analysis stage"
#             directory = 0,     # The directory for output (0 for standard out)
#             a = 1,             # Start coord for x-axis
#             b = rnaSize(cds),  # End coord for x-axis
#             c = 1,             # Start coord for y-axis
#             d = rnaSize(cds),  # End coord for y-axis
#             h = 5)             # The height of the image (if saved)

A plot for two chosen samples and analysis stages in the analysis can be made using the plotCombinedMatrix function.

plotCombinedMatrix(cds,
           type1 = "original",
           type2 = "noHost",
           b = rnaSize(cds),
           d = rnaSize(cds))

See which samples and analysis stages are available by checking the status of the object.

trimmedClusters
#> rnaCrosslinkDataSet Object 
#> RNAs Analysed                -              -  ENSG000000XXXXX_NR003286-2_RN18S1_rRNA 
#> Samples Analysed             -              -  s1 c1 
#> InputFiles           - Raw data               -  original host noHost 
#> matrixList         - Contact Matricies      -  noHost original originalClusters superClusters trimmedClusters 
#> clusterTableList   - Cluster positions      -  original superClusters trimmedClusters 
#> clusterGrangesList - Granges of clusters    -  original superClusters trimmedClusters 
#> interactionTable   - Predictied interaction -  0 
#> viennaStructures   - Predicted Structures   - 0

A plot for all samples can be made using the plotMatricesAverage function. The plot can display up to two chosen analysis stages on separate halves.

# Plot heatmaps for all samples combined and all controls combined
plotMatricesAverage(cds = trimmedClusters, # The rnaCrosslinkDataSet instance 
             type1 = "trimmedClusters", # The "analysis stage" to plot on the upper half of the heatmap
             type2 = "original",        # The "analysis stage" to plot on the lower half of the heatmap
             directory = 0,     # The directory for output (0 for standard out)
             a = 1,             # Start coord for x-axis
             b = rnaSize(cds),  # End coord for x-axis
             c = 1,             # Start coord for y-axis
             d = rnaSize(cds),  # End coord for y-axis
             h = 5)             # The height of the image (if saved)


6.2 Identifying domains


With large RNAS (?500bp), it can be useful to segment the RNA and fold the segments seaparately. DNA and RNA that form secondary and tertiary structures often have domains where there is more inter-domain interactions that inra-domain interactions. The TopDom package was designed to identify these domains for HI-C data. Using this package you can identify domains in the RNA structural data and can be used to inform the folding.

domainDF = data.frame()
for(j in c(20,30,40,50,60,70)){
    #for(i in which(sampleTable(cds)$group == "s")){
    
    timeMats = as.matrix(getData(x = cds, 
                                 data = "matrixList", 
                                 type = "noHost")[[1]])
    
    timeMats = timeMats/ (sum(timeMats)/1000000)
    tmp = tempfile()
    write.table(timeMats, file = tmp,quote = F,row.names = F, col.names = F)
    
    tdData2 = readHiC(
        file = tmp,
        chr = "rna18s",
        binSize = 10,
        debug = getOption("TopDom.debug", FALSE)
    )
    
    tdData =  TopDom(
        tdData2 ,
        window.size = j,
        outFile = NULL,
        statFilter = TRUE,
        debug = getOption("TopDom.debug", FALSE)
    )
    
    td = tdData$domain
    td$sample = sampleTable(cds)$sampleName[1]
    td$window = j
    domainDF = rbind.data.frame(td, domainDF)
    
}



ggplot(domainDF) +
    geom_segment(aes(x = from.coord/10,
                     xend = to.coord/10, y = as.factor(sub("s","",sample)),
                     yend = (as.factor(sub("s","",sample)) ), colour = tag),
                 size  = 20, alpha = 0.8) +
    facet_grid(window~.)+
    theme_bw()

6.3

6.4 Analyse folds


6.4.1 Ensemble Stats

6.4.2 HotSpots of difference

6.4.3 PCA of ensembl

A PCA of the structural ensembl can be made.

plotEnsemblePCA(foldedCds, 
                labels = T, # plot labels for structures
                split = T)  # split samples over different facets (T/f)


6.4.4 Plot to strcutures on an arc diagram

Compare two structures from the ensembl

plotComparisonArc(foldedCds = foldedCds,
                  s1 = "c1",            # The sample of the 1st structure
                  s2 = "s1",            # The sample of the 2nd structure
                  n1 = 13,               # The number of the 1st structure
                  n2 = 16)               # The number of the 2nd structure


6.4.5 Plot one structure

plotStructure(foldedCds = foldedCds, 
              rnaRefs = rnaRefs,     
              s = "s1",          # The sample of the structure
              n = 1)             # The number of the structure


6.5 Inter RNA interactions- Plot an interacting partner

Along with the RNA of interest the data also contains inter-RNA interactions with other RNAs from the transcriptome reference. After identifying abundant interactions using topInteractions you can find out where on each RNA these inetractions occur using getInteractions and getReverseInteractions.


getInteractions(cds,
                "ENSG00000XXXXXX_NR003287-2_RN28S1_rRNA") %>%
    mutate(sample =sub("\\d$","",sample) )%>%
    group_by(rna,Position,sample)%>%
    summarise(sum =  sum(depth)) %>%
    ggplot()+
    geom_area(aes(x = Position,
                  y = sum, 
                  fill = sample), 
              stat = "identity")+
    facet_grid(sample~.) +
    theme_bw()
#> `summarise()` has grouped output by 'rna', 'Position'. You can override using
#> the `.groups` argument.

getReverseInteractions(cds,
                       rna) %>%
    mutate(sample =sub("\\d$","",sample) )%>%
    group_by(rna,Position,sample)%>%
    summarise(sum =  sum(depth)) %>%
    ggplot()+
    geom_area(aes(x = Position,
                  y = sum, 
                  fill = sample), 
                    stat = "identity")+
    facet_grid(sample~.)+
    theme_bw()
#> `summarise()` has grouped output by 'rna', 'Position'. You can override using
#> the `.groups` argument.

These interactions can be plotted as contact matrices using plotInteractions.

plotInteractions(cds,
                 rna = "ENSG000000XXXXX_NR003286-2_RN18S1_rRNA",
                 interactor = "ENSG00000XXXXXX_NR003287-2_RN28S1_rRNA",
                 b = "max",
                 d = "max")

Plot heatmaps of interactions for all samples combined and all controls combined using plotInteractionsAverage

plotInteractionsAverage(cds,
                 rna = "ENSG000000XXXXX_NR003286-2_RN18S1_rRNA",
                 interactor = "ENSG00000XXXXXX_NR003287-2_RN28S1_rRNA",
                 b = "max",
                 d = "max")


6.6 Compare to the “Known” structure

The clusters can be compared to set of interactions to see which clusters share coordinates with a this set of interactions. The table should be formatted as a tabale fame of 2 columns (i and j) each colunn containing numerical values giving an interaction between i and j with which the clusters should be compared.


6.6.1 Make a contact matrix of known / comprative interactions

To compare to set of know interactions you need a contact matrix these interactions, for plotting it is sometimes useful to expand the interactions so they can be seen easily.

expansionSize = 5
knownMat = matrix(0, nrow = rnaSize(cds), ncol = rnaSize(cds))
for(i in 1:nrow(known18S)){
    knownMat[ (known18S$V1[i]-expansionSize):(known18S$V1[i]+expansionSize),
              (known18S$V2[i]-expansionSize):(known18S$V2[i]+expansionSize)] =
        knownMat[(known18S$V1[i]-expansionSize):(known18S$V1[i]+expansionSize),
                 (known18S$V2[i]-expansionSize):(known18S$V2[i]+expansionSize)] +1
}
knownMat = knownMat + t(knownMat)


6.6.2 Compare the Clusters

Using compareKnown you can check which clusters agree with the set of interactions. This functions adds analysis stages “known”, “novel” and “knownAndNovel” to the objects data attributes.

# use compare known to gett he known and not know clusters
knowClusteredCds = compareKnown(trimmedClusters, # The rnaCrosslinkDataSet instance 
                                knownMat, # A contact matrix of know interactions
                                "trimmedClusters") # The analysis stage of clustering to compare 

knowClusteredCds
#> rnaCrosslinkDataSet Object 
#> RNAs Analysed                -              -  ENSG000000XXXXX_NR003286-2_RN18S1_rRNA 
#> Samples Analysed             -              -  s1 c1 
#> InputFiles           - Raw data               -  original host noHost 
#> matrixList         - Contact Matricies      -  noHost original originalClusters superClusters trimmedClusters KnownAndNovel novel known 
#> clusterTableList   - Cluster positions      -  original superClusters trimmedClusters novel known 
#> clusterGrangesList - Granges of clusters    -  original superClusters trimmedClusters 
#> interactionTable   - Predictied interaction -  0 
#> viennaStructures   - Predicted Structures   - 0


6.6.3 Plot the overlapping clusters

You can plot these using the plotMatrices function

# Plot heatmaps for all samples combined and all controls combined
plotMatricesAverage(cds = knowClusteredCds, # The rnaCrosslinkDataSet instance 
             type1 = "KnownAndNovel", # The "analysis stage"
             directory = 0,     # The directory for output (0 for standard out)
             a = 1,             # Start coord for x-axis
             b = rnaSize(cds),  # End coord for x-axis
             c = 1,             # Start coord for y-axis
             d = rnaSize(cds),  # End coord for y-axis
             h = 5)             # The hight of the image (if saved)


6.6.4 Cluster Numbers

# Get the number of clusters for each analysis Stage
clusterNumbers(knowClusteredCds)


6.6.5 Read numbers in clusters

# Get the number of reads in each cluster for each analysis stage
readNumbers(knowClusteredCds)


6.6.6 Compare structures with known

To compare predicted structures with the know stucture use “compareKnownStructures”. This will give you the number of base pairs that agree between the ensembl of predicted structures and the structure imputted for comparison. This can be for better viewing.

head(compareKnownStructures(foldedCds, 
                            known18S)) # the comarison set
ggplot(compareKnownStructures(foldedCds, known18S)) +
    geom_hline(yintercept = c(0.5,0.25,0.75,0,1), 
               colour = "grey", 
               alpha = 0.2)+
    geom_vline(xintercept = c(0.5,0.25,0.75,0,1), 
               colour = "grey", 
               alpha = 0.2)+
    geom_point(aes(x = sensitivity, 
                   y = precision, 
                   size = as.numeric(as.character(unlist(foldedCds@dgs))),
                   colour = str_sub(structureID, 
                                    start = 1 , 
                                    end = 2))) +
    xlim(0,1)+
    ylim(0,1)+
    theme_classic()

7 Quick start


The package ships with a subsetted version of the unenriched dataset which can be used to follow the vignette, the full dataset can be found here: Un-enriched rRNA dataset. There is also a function makeExamplernaCrosslinkDataSet() from the rnaCrosslinkOO package that will create a simple toy example rnaCrosslinkDataSet object, follow this small section to get a feel for the package and it’s functionality. The dataset has 1 sample consisting of a control and sample.

# make an example dataset
cds = makeExamplernaCrosslinkDataSet()
cds

By plotting the reads on a 2D heatmap you can see structured areas of the transcript and long / short distance inter-RNA interactions. The “type” argument can be changed to plot any analysis stage in the matrixList slot which will become populated as the analysis proceeds.

# Have a look at the reads for each sample 
plotMatricesAverage(cds = cds,
                    type1 = "original",
                    directory = 0,
                    a = 1,
                    b = rnaSize(cds),
                    c = 1,
                    d = rnaSize(cds),
                    h = 5)

Find the RNAs that interact with the RNA of interest.

topInteracters(cds,2)

Get some more information about the RNAs in the sample and thier abundance in each sample. With more RNAS and transcripts this becomes very useful as a count matrix.

featureInfo(cds)

Clustering and cluster trimming.

clusteredCds = clusterrnaCrosslink(cds = cds,
                               cores = 1,
                               stepCount = 2,
                               clusterCutoff = 0)






trimmedClusters = trimClusters(clusteredCds = clusteredCds,
                               trimFactor = 1, 
                               clusterCutoff = 0)

Plot them to check the clustering and trimming is working as expected.

plotMatricesAverage(cds = clusteredCds,
                    type1 = "originalClusters",
                    directory = 0,
                    a = 1,
                    b = rnaSize(cds),
                    c = 1,
                    d = rnaSize(cds),
                    h = 5)
plotMatricesAverage(cds = trimmedClusters,
                    type1 = "trimmedClusters",
                    directory = 0,
                    a = 1,
                    b = rnaSize(cds),
                    c = 1,
                    d = rnaSize(cds),
                    h = 5)

Folding:


fasta = paste(c(rep('A',25),
                rep('T',25),
                rep('A',10),
                rep('T',23)),collapse = "")

header = '>transcript1'


fastaFile = tempfile()
writeLines(paste(header,fasta,sep = "\n"),con = fastaFile)


rnaRefs = list()
rnaRefs[[rnas(cds)]] = read.fasta(fastaFile)
rnaRefs



foldedCds = foldrnaCrosslink(trimmedClusters,
                         rnaRefs = rnaRefs,
                         start = 1,
                         end = 83,
                         shape = 0,
                         ensembl = 5,
                         constraintNumber  = 1,
                         evCutoff = 1)

If you have a set of nucloetide contacts, you can check to see if they exist in the set of predicted structures after folding. Also see compareKnown which is a similar function but tests the set of interactions against the clusters.

# make an example table of "know" interactions
file = data.frame(V1 = c(6),
                  V2 = c(80))

compareKnownStructures(foldedCds,file)

Plot a PCA of the predicted structures


plotEnsemblePCA(foldedCds, labels = T,split = T)

Compare two structures

plotComparisonArc(foldedCds = foldedCds,"s1","c1",2,3)

Plot one structure

plotStructure(foldedCds = foldedCds,"c1",1)