1 #ifndef VIENNA_RNA_PACKAGE_FOLD_COMPOUND_H 2 #define VIENNA_RNA_PACKAGE_FOLD_COMPOUND_H 76 #define VRNA_STATUS_MFE_PRE (unsigned char)1 84 #define VRNA_STATUS_MFE_POST (unsigned char)2 91 #define VRNA_STATUS_PF_PRE (unsigned char)3 98 #define VRNA_STATUS_PF_POST (unsigned char)4 154 unsigned int strands;
208 #ifndef VRNA_DISABLE_C11_FEATURES 225 short *sequence_encoding2;
248 #ifndef VRNA_DISABLE_C11_FEATURES 300 #ifndef VRNA_DISABLE_C11_FEATURES 346 #define VRNA_OPTION_DEFAULT 0U 354 #define VRNA_OPTION_MFE 1U 362 #define VRNA_OPTION_PF 2U 367 #define VRNA_OPTION_HYBRID 4U 378 #define VRNA_OPTION_EVAL_ONLY 8U 383 #define VRNA_OPTION_WINDOW 16U 425 unsigned int options);
468 unsigned int options);
472 vrna_fold_compound_comparative2(
const char **
sequences,
474 const unsigned char *orientation,
475 const unsigned long long *start,
476 const unsigned long long *genome_size,
478 unsigned int options);
482 vrna_fold_compound_TwoD(
const char *
sequence,
486 unsigned int options);
491 unsigned int options);
short ** S3
Sl[s][i] holds next base 3' of i in sequence s.
Definition: fold_compound.h:277
short ** S
Numerical encoding of the sequences in the alignment.
Definition: fold_compound.h:271
Definition: structured_domains.h:26
Functions and data structures for secondary structure soft constraints.
unsigned int * mm1
Maximum matching matrix, reference struct 1 disallowed.
Definition: fold_compound.h:320
Minimum Free Energy (MFE) Dynamic Programming (DP) matrices data structure required within the vrna_f...
Definition: dp_matrices.h:46
vrna_fold_compound_t * vrna_fold_compound_comparative(const char **sequences, vrna_md_t *md_p, unsigned int options)
Retrieve a vrna_fold_compound_t data structure for sequence alignments.
unsigned int * strand_end
The end (last) position of a particular strand within the current concatenated sequence.
Definition: fold_compound.h:152
short * S_cons
Numerical encoding of the consensus sequence.
Definition: fold_compound.h:268
char * ptype
Pair type array.
Definition: fold_compound.h:226
Functions and data structures related to sequence representations ,.
Functions to deal with standard dynamic programming (DP) matrices.
short * sequence_encoding
Numerical encoding of the input sequence.
Definition: fold_compound.h:221
vrna_exp_param_t * exp_params
The precomputed free energy contributions as Boltzmann factors.
Definition: fold_compound.h:164
Data structure to store all functionality for ligand binding.
Definition: unstructured_domains.h:228
unsigned int * bpdist
Matrix containing base pair distance of reference structure 1 and 2 on interval [i,j].
Definition: fold_compound.h:318
short * reference_pt1
A pairtable of the first reference structure.
Definition: fold_compound.h:313
vrna_sc_t * sc
The soft constraints for usage in structure prediction and evaluation.
Definition: fold_compound.h:240
Definition: sequence.h:52
The most basic data structure required by many functions throughout the RNAlib.
Definition: fold_compound.h:132
char ** sequences
The aligned sequences.
Definition: fold_compound.h:258
The model details data structure and its corresponding modifiers.
void * auxdata
A pointer to auxiliary, user-defined data.
Definition: fold_compound.h:180
The datastructure that contains temperature scaled energy parameters.
Definition: basic.h:57
short * pscore_pf_compat
Precomputed array of pair types expressed as pairing scores indexed via iindx.
Definition: fold_compound.h:288
vrna_sd_t * domains_struc
Additional structured domains.
Definition: fold_compound.h:196
vrna_ud_t * domains_up
Additional unstructured domains.
Definition: fold_compound.h:199
char * cons_seq
The consensus sequence of the aligned sequences.
Definition: fold_compound.h:265
unsigned int * strand_order
The strand order, i.e. permutation of current concatenated sequence.
Definition: fold_compound.h:150
vrna_hc_t * hc
The hard constraints data structure used for structure prediction.
Definition: fold_compound.h:158
char * ptype_pf_compat
ptype array indexed via iindx
Definition: fold_compound.h:235
int * jindx
DP matrix accessor.
Definition: fold_compound.h:167
vrna_fc_type_e
An enumerator that is used to specify the type of a vrna_fold_compound_t.
Definition: fold_compound.h:114
vrna_fold_compound_t * vrna_fold_compound(const char *sequence, vrna_md_t *md_p, unsigned int options)
Retrieve a vrna_fold_compound_t data structure for single sequences and hybridizing sequences...
void vrna_fold_compound_free(vrna_fold_compound_t *fc)
Free memory occupied by a vrna_fold_compound_t.
The data structure that contains the complete model details used throughout the calculations.
Definition: model.h:180
The soft constraints data structure.
Definition: soft.h:171
short ** S5
S5[s][i] holds next base 5' of i in sequence s.
Definition: fold_compound.h:274
The data structure that contains temperature scaled Boltzmann weights of the energy parameters...
Definition: basic.h:103
vrna_sc_t ** scs
A set of soft constraints (for each sequence in the alignment)
Definition: fold_compound.h:292
void( vrna_callback_free_auxdata)(void *data)
Callback to free memory allocated for auxiliary user-provided data.
Definition: fold_compound.h:46
Functions and data structures for handling of secondary structure hard constraints.
The hard constraints data structure.
Definition: hard.h:371
Definition: fold_compound.h:116
Functions to modify unstructured domains, e.g. to incorporate ligands binding to unpaired stretches...
Data structure representing a nucleotide sequence.
Definition: sequence.h:41
unsigned int * strand_number
The strand number a particular nucleotide is associated with.
Definition: fold_compound.h:149
void( vrna_callback_recursion_status)(unsigned char status, void *data)
Callback to perform specific user-defined actions before, or after recursive computations.
Definition: fold_compound.h:67
vrna_param_t * params
The precomputed free energy contributions for each type of loop.
Definition: fold_compound.h:163
unsigned int * strand_start
The start position of a particular strand within the current concatenated sequence.
Definition: fold_compound.h:151
int * pscore
Precomputed array of pair types expressed as pairing scores.
Definition: fold_compound.h:282
unsigned int n_seq
The number of sequences in the alignment.
Definition: fold_compound.h:262
unsigned int * referenceBPs2
Matrix containing number of basepairs of reference structure2 in interval [i,j].
Definition: fold_compound.h:317
void vrna_fold_compound_add_callback(vrna_fold_compound_t *fc, vrna_callback_recursion_status *f)
Add a recursion status callback to the vrna_fold_compound_t.
char * sequence
The input sequence string.
Definition: fold_compound.h:218
vrna_mx_mfe_t * matrices
The MFE DP matrices.
Definition: fold_compound.h:160
Definition: fold_compound.h:115
vrna_callback_recursion_status * stat_cb
Recursion status callback (usually called just before, and after recursive computations in the librar...
Definition: fold_compound.h:175
int cutpoint
The position of the (cofold) cutpoint within the provided sequence. If there is no cutpoint...
Definition: fold_compound.h:145
int ** pscore_local
Precomputed array of pair types expressed as pairing scores.
Definition: fold_compound.h:285
vrna_callback_free_auxdata * free_auxdata
A callback to free auxiliary user data whenever the fold_compound itself is free'd.
Definition: fold_compound.h:184
unsigned int length
The length of the sequence (or sequence alignment)
Definition: fold_compound.h:144
Functions to deal with sets of energy parameters.
short * reference_pt2
A pairtable of the second reference structure.
Definition: fold_compound.h:314
This module provides interfaces that deal with additional structured domains in the folding grammar...
unsigned int maxD1
Maximum allowed base pair distance to first reference.
Definition: fold_compound.h:311
unsigned int * mm2
Maximum matching matrix, reference struct 2 disallowed.
Definition: fold_compound.h:321
unsigned int * referenceBPs1
Matrix containing number of basepairs of reference structure1 in interval [i,j].
Definition: fold_compound.h:316
Implementations for the RNA folding grammar.
void vrna_fold_compound_add_auxdata(vrna_fold_compound_t *fc, void *data, vrna_callback_free_auxdata *f)
Add auxiliary data to the vrna_fold_compound_t.
int window_size
window size for local folding sliding window approach
Definition: fold_compound.h:333
char ** ptype_local
Pair type array (for local folding)
Definition: fold_compound.h:334
const vrna_fc_type_e type
The type of the vrna_fold_compound_t.
Definition: fold_compound.h:137
int * iindx
DP matrix accessor.
Definition: fold_compound.h:166
Partition function (PF) Dynamic Programming (DP) matrices data structure required within the vrna_fol...
Definition: dp_matrices.h:204
unsigned int maxD2
Maximum allowed base pair distance to second reference.
Definition: fold_compound.h:312
vrna_mx_pf_t * exp_matrices
The PF DP matrices.
Definition: fold_compound.h:161