1 /// @file htslib/synced_bcf_reader.h
2 /// Stream through multiple VCF files.
3 /*
4     Copyright (C) 2012-2017, 2019-2020 Genome Research Ltd.
5 
6     Author: Petr Danecek <pd3@sanger.ac.uk>
7 
8 Permission is hereby granted, free of charge, to any person obtaining a copy
9 of this software and associated documentation files (the "Software"), to deal
10 in the Software without restriction, including without limitation the rights
11 to use, copy, modify, merge, publish, distribute, sublicense, and/or sell
12 copies of the Software, and to permit persons to whom the Software is
13 furnished to do so, subject to the following conditions:
14 
15 The above copyright notice and this permission notice shall be included in
16 all copies or substantial portions of the Software.
17 
18 THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR
19 IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,
20 FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL
21 THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER
22 LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING
23 FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER
24 DEALINGS IN THE SOFTWARE.  */
25 
26 /*
27     The synced_bcf_reader allows to keep multiple VCFs open and stream them
28     using the next_line iterator in a seamless matter without worrying about
29     chromosomes and synchronizing the sites. This is used by vcfcheck to
30     compare multiple VCFs simultaneously and is used also for merging,
31     creating intersections, etc.
32 
33     The synced_bcf_reader also provides API for reading indexed BCF/VCF,
34     hiding differences in BCF/VCF opening, indexing and reading.
35 
36 
37     Example of usage:
38 
39         bcf_srs_t *sr = bcf_sr_init();
40         bcf_sr_set_opt(sr, BCF_SR_PAIR_LOGIC, BCF_SR_PAIR_BOTH_REF);
41         bcf_sr_set_opt(sr, BCF_SR_REQUIRE_IDX);
42         for (i=0; i<nfiles; i++)
43             bcf_sr_add_reader(sr,files[i]);
44         while ( bcf_sr_next_line(sr) )
45         {
46             for (i=0; i<nfiles; i++)
47             {
48                 bcf1_t *line = bcf_sr_get_line(sr,i);
49                 ...
50             }
51         }
52         if ( sr->errnum ) error("Error: %s\n", bcf_sr_strerror(sr->errnum));
53         bcf_sr_destroy(sr);
54 */
55 module htslib.synced_bcf_reader;
56 
57 import core.stdc.stddef;
58 
59 import htslib.hts;
60 import htslib.vcf;
61 import htslib.kstring : kstring_t;
62 import htslib.tbx : tbx_t;
63 
64 @system:
65 nothrow:
66 @nogc:
67 
68 extern (C):
69 
70 /*
71     When reading multiple files in parallel, duplicate records within each
72     file will be reordered and offered in intuitive order. For example,
73     when reading two files, each with unsorted SNP and indel record, the
74     reader should return the SNP records together and the indel records
75     together. The logic of compatible records can vary depending on the
76     application and can be set using the PAIR_* defined below.
77 
78     The COLLAPSE_* definitions will be deprecated in future versions, please
79     use the PAIR_* definitions instead.
80 */
81 enum COLLAPSE_NONE = 0; // require the exact same set of alleles in all files
82 enum COLLAPSE_SNPS = 1; // allow different alleles, as long as they all are SNPs
83 enum COLLAPSE_INDELS = 2; // the same as above, but with indels
84 enum COLLAPSE_ANY = 4; // any combination of alleles can be returned by bcf_sr_next_line()
85 enum COLLAPSE_SOME = 8; // at least some of the ALTs must match
86 enum COLLAPSE_BOTH = COLLAPSE_SNPS | COLLAPSE_INDELS;
87 
88 enum BCF_SR_PAIR_SNPS = 1 << 0; // allow different alleles, as long as they all are SNPs
89 enum BCF_SR_PAIR_INDELS = 1 << 1; // the same as above, but with indels
90 enum BCF_SR_PAIR_ANY = 1 << 2; // any combination of alleles can be returned by bcf_sr_next_line()
91 enum BCF_SR_PAIR_SOME = 1 << 3; // at least some of multiallelic ALTs must match. Implied by all the others with the exception of EXACT
92 enum BCF_SR_PAIR_SNP_REF = 1 << 4; // allow REF-only records with SNPs
93 enum BCF_SR_PAIR_INDEL_REF = 1 << 5; // allow REF-only records with indels
94 enum BCF_SR_PAIR_EXACT = 1 << 6; // require the exact same set of alleles in all files
95 enum BCF_SR_PAIR_BOTH = BCF_SR_PAIR_SNPS | BCF_SR_PAIR_INDELS;
96 enum BCF_SR_PAIR_BOTH_REF = BCF_SR_PAIR_SNPS | BCF_SR_PAIR_INDELS | BCF_SR_PAIR_SNP_REF | BCF_SR_PAIR_INDEL_REF;
97 
98 enum bcf_sr_opt_t
99 {
100     BCF_SR_REQUIRE_IDX = 0,
101     BCF_SR_PAIR_LOGIC = 1, // combination of the PAIR_* values above
102     BCF_SR_ALLOW_NO_IDX = 2 // allow to proceed even if required index is not present (at the user's risk)
103 }
104 
105 struct bcf_sr_region_t;
106 
107 struct bcf_sr_regions_t
108 {
109     // for reading from tabix-indexed file (big data)
110     tbx_t* tbx; // tabix index
111     hts_itr_t* itr; // tabix iterator
112     kstring_t line; // holder of the current line, set only when reading from tabix-indexed files
113     htsFile* file;
114     char* fname;
115     int is_bin; // is open in binary mode (tabix access)
116     char** als; // parsed alleles if targets_als set and _regions_match_alleles called
117     kstring_t als_str; // block of parsed alleles
118     int nals;
119     int mals; // number of set alleles and the size of allocated array
120     int als_type; // alleles type, currently VCF_SNP or VCF_INDEL
121 
122     // user handler to deal with skipped regions without a counterpart in VCFs
123     void function(bcf_sr_regions_t*, void*) missed_reg_handler;
124     void* missed_reg_data;
125 
126     // for in-memory regions (small data)
127     bcf_sr_region_t* regs; // the regions
128 
129     // shared by both tabix-index and in-memory regions
130     void* seq_hash; // keys: sequence names, values: index to seqs
131     char** seq_names; // sequence names
132     int nseqs; // number of sequences (chromosomes) in the file
133     int iseq; // current position: chr name, index to snames
134     hts_pos_t start;
135     hts_pos_t end; // current position: start, end of the region (0-based)
136     int prev_seq;
137     hts_pos_t prev_start;
138     hts_pos_t prev_end;
139 }
140 
141 struct bcf_sr_t
142 {
143     htsFile* file;
144     tbx_t* tbx_idx;
145     hts_idx_t* bcf_idx;
146     bcf_hdr_t* header;
147     hts_itr_t* itr;
148     char* fname;
149     bcf1_t** buffer; // cached VCF records. First is the current record synced across the reader
150     int nbuffer;
151     int mbuffer; // number of cached records (including the current record); number of allocated records
152     int nfilter_ids;
153     int* filter_ids; // -1 for ".", otherwise filter id as returned by bcf_hdr_id2int
154     int* samples;
155     int n_smpl; // list of columns in the order consistent with bcf_srs_t.samples
156 }
157 
158 enum bcf_sr_error
159 {
160     open_failed = 0,
161     not_bgzf = 1,
162     idx_load_failed = 2,
163     file_type_error = 3,
164     api_usage_error = 4,
165     header_error = 5,
166     no_eof = 6,
167     no_memory = 7,
168     vcf_parse_error = 8,
169     bcf_read_error = 9,
170     noidx_error = 10
171 }
172 
173 struct bcf_srs_t
174 {
175     // Parameters controlling the logic
176     int collapse; // Do not access directly, use bcf_sr_set_pairing_logic() instead
177     char* apply_filters; // If set, sites where none of the FILTER strings is listed
178     // will be skipped. Active only at the time of
179     // initialization, that is during the add_reader()
180     // calls. Therefore, each reader can be initialized with different
181     // filters.
182     int require_index; // Some tools do not need random access
183     int max_unpack; // When reading VCFs and knowing some fields will not be needed, boost performance of vcf_parse1
184     int* has_line; // Corresponds to return value of bcf_sr_next_line but is not limited by sizeof(int). Use bcf_sr_has_line macro to query.
185     bcf_sr_error errnum;
186 
187     // Auxiliary data
188     bcf_sr_t* readers;
189     int nreaders;
190     int streaming; // reading mode: index-jumping or streaming
191     int explicit_regs; // was the list of regions se by bcf_sr_set_regions or guessed from tabix index?
192     char** samples; // List of samples
193     bcf_sr_regions_t* regions;
194     bcf_sr_regions_t* targets; // see bcf_sr_set_[targets|regions] for description
195     int targets_als; // subset to targets not only by position but also by alleles?
196     int targets_exclude;
197     kstring_t tmps;
198     int n_smpl;
199 
200     int n_threads; // Simple multi-threaded decoding / encoding.
201     htsThreadPool* p; // Our pool, but it can be used by others if needed.
202     void* aux; // Opaque auxiliary data
203 }
204 
205 /** Allocate and initialize a bcf_srs_t struct.
206  *
207  *  The bcf_srs_t struct returned by a successful call should be freed
208  *  via bcf_sr_destroy() when it is no longer needed.
209  */
210 bcf_srs_t* bcf_sr_init();
211 
212 /** Destroy a bcf_srs_t struct */
213 void bcf_sr_destroy(bcf_srs_t* readers);
214 
215 char* bcf_sr_strerror(int errnum);
216 
217 int bcf_sr_set_opt(bcf_srs_t* readers, bcf_sr_opt_t opt, ...);
218 
219 /**
220  * bcf_sr_set_threads() - allocates a thread-pool for use by the synced reader.
221  * @n_threads: size of thread pool
222  *
223  * Returns 0 if the call succeeded, or <0 on error.
224  */
225 int bcf_sr_set_threads(bcf_srs_t* files, int n_threads);
226 
227 /** Deallocates thread memory, if owned by us. */
228 void bcf_sr_destroy_threads(bcf_srs_t* files);
229 
230 /**
231  *  bcf_sr_add_reader() - open new reader
232  *  @readers: holder of the open readers
233  *  @fname:   the VCF file
234  *
235  *  Returns 1 if the call succeeded, or 0 on error.
236  *
237  *  See also the bcf_srs_t data structure for parameters controlling
238  *  the reader's logic.
239  */
240 int bcf_sr_add_reader(bcf_srs_t* readers, const(char)* fname);
241 
242 void bcf_sr_remove_reader(bcf_srs_t* files, int i);
243 
244 /**
245  * bcf_sr_next_line() - the iterator
246  * @readers:    holder of the open readers
247  *
248  * Returns the number of readers which have the current line
249  * (bcf_sr_t.buffer[0]) set at this position. Use the bcf_sr_has_line macro to
250  * determine which of the readers are set.
251  */
252 int bcf_sr_next_line(bcf_srs_t* readers);
253 
254 extern (D) auto bcf_sr_has_line(T0, T1)(auto ref T0 readers, auto ref T1 i)
255 {
256     return readers.has_line[i];
257 }
258 
259 extern (D) auto bcf_sr_get_line(T0, T1)(auto ref T0 _readers, auto ref T1 i)
260 {
261     return _readers.has_line[i] ? (_readers.readers[i].buffer[0]) : cast(bcf1_t*) NULL;
262 }
263 
264 extern (D) int bcf_sr_region_done(T0, T1)(auto ref T0 _readers, auto ref T1 i)
265 {
266     return !_readers.has_line[i] && !_readers.readers[i].nbuffer ? 1 : 0;
267 }
268 
269 extern (D) auto bcf_sr_get_header(T0, T1)(auto ref T0 _readers, auto ref T1 i)
270 {
271     return _readers.readers[i].header;
272 }
273 
274 extern (D) auto bcf_sr_get_reader(T0, T1)(auto ref T0 _readers, auto ref T1 i)
275 {
276     return &(_readers.readers[i]);
277 }
278 
279 /**
280  *  bcf_sr_seek() - set all readers to selected position
281  *  @seq:  sequence name; NULL to seek to start
282  *  @pos:  0-based coordinate
283  */
284 int bcf_sr_seek(bcf_srs_t* readers, const(char)* seq, hts_pos_t pos);
285 
286 /**
287  * bcf_sr_set_samples() - sets active samples
288  * @readers: holder of the open readers
289  * @samples: this can be one of: file name with one sample per line;
290  *           or column-separated list of samples; or '-' for a list of
291  *           samples shared by all files. If first character is the
292  *           exclamation mark, all but the listed samples are included.
293  * @is_file: 0: list of samples; 1: file with sample names
294  *
295  * Returns 1 if the call succeeded, or 0 on error.
296  */
297 int bcf_sr_set_samples(bcf_srs_t* readers, const(char)* samples, int is_file);
298 
299 /**
300  *  bcf_sr_set_targets(), bcf_sr_set_regions() - init targets/regions
301  *  @readers:   holder of the open readers
302  *  @targets:   list of regions, one-based and inclusive.
303  *  @is_fname:  0: targets is a comma-separated list of regions (chr,chr:from-to)
304  *              1: targets is a tabix indexed file with a list of regions
305  *              (<chr,pos> or <chr,from,to>)
306  *
307  *  Returns 0 if the call succeeded, or -1 on error.
308  *
309  *  Both functions behave the same way, unlisted positions will be skipped by
310  *  bcf_sr_next_line(). However, there is an important difference: regions use
311  *  index to jump to desired positions while targets streams the whole files
312  *  and merely skip unlisted positions.
313  *
314  *  Moreover, bcf_sr_set_targets() accepts an optional parameter $alleles which
315  *  is interpreted as a 1-based column index in the tab-delimited file where
316  *  alleles are listed. This in principle enables to perform the COLLAPSE_*
317  *  logic also with tab-delimited files. However, the current implementation
318  *  considers the alleles merely as a suggestion for prioritizing one of possibly
319  *  duplicate VCF lines. It is up to the caller to examine targets->als if
320  *  perfect match is sought after. Note that the duplicate positions in targets
321  *  file are currently not supported.
322  *  Targets (but not regions) can be prefixed with "^" to request logical complement,
323  *  for example "^X,Y,MT" indicates that sequences X, Y and MT should be skipped.
324  *
325  *  API note: bcf_sr_set_regions/bcf_sr_set_targets MUST be called before the
326  *  first call to bcf_sr_add_reader().
327  */
328 int bcf_sr_set_targets(
329     bcf_srs_t* readers,
330     const(char)* targets,
331     int is_file,
332     int alleles);
333 
334 int bcf_sr_set_regions(bcf_srs_t* readers, const(char)* regions, int is_file);
335 
336 /*
337  *  bcf_sr_regions_init()
338  *  @regions:   regions can be either a comma-separated list of regions
339  *              (chr|chr:pos|chr:from-to|chr:from-) or VCF, BED, or
340  *              tab-delimited file (the default). Uncompressed files
341  *              are stored in memory while bgzip-compressed and tabix-indexed
342  *              region files are streamed.
343  *  @is_file:   0: regions is a comma-separated list of regions
344  *                  (chr|chr:pos|chr:from-to|chr:from-)
345  *              1: VCF, BED or tab-delimited file
346  *  @chr, from, to:
347  *              Column indexes of chromosome, start position and end position
348  *              in the tab-delimited file. The positions are 1-based and
349  *              inclusive.
350  *              These parameters are ignored when reading from VCF, BED or
351  *              tabix-indexed files. When end position column is not present,
352  *              supply 'from' in place of 'to'. When 'to' is negative, first
353  *              abs(to) will be attempted and if that fails, 'from' will be used
354  *              instead.
355  *
356  *  The bcf_sr_regions_t struct returned by a successful call should be freed
357  *  via bcf_sr_regions_destroy() when it is no longer needed.
358  */
359 bcf_sr_regions_t* bcf_sr_regions_init(
360     const(char)* regions,
361     int is_file,
362     int chr,
363     int from,
364     int to);
365 
366 void bcf_sr_regions_destroy(bcf_sr_regions_t* regions);
367 
368 /*
369  *  bcf_sr_regions_seek() - seek to the chromosome block
370  *
371  *  Returns 0 on success or -1 on failure. Sets reg->seq appropriately and
372  *  reg->start,reg->end to -1.
373  */
374 int bcf_sr_regions_seek(bcf_sr_regions_t* regions, const(char)* chr);
375 
376 /*
377  *  bcf_sr_regions_next() - retrieves next region. Returns 0 on success and -1
378  *  when all regions have been read. The fields reg->seq, reg->start and
379  *  reg->end are filled with the genomic coordinates on success or with
380  *  NULL,-1,-1 when no region is available. The coordinates are 0-based,
381  *  inclusive.
382  */
383 int bcf_sr_regions_next(bcf_sr_regions_t* reg);
384 
385 /*
386  *  bcf_sr_regions_overlap() - checks if the interval <start,end> overlaps any of
387  *  the regions, the coordinates are 0-based, inclusive. The coordinate queries
388  *  must come in ascending order.
389  *
390  *  Returns 0 if the position is in regions; -1 if the position is not in the
391  *  regions and more regions exist; -2 if not in the regions and there are no more
392  *  regions left.
393  */
394 int bcf_sr_regions_overlap(
395     bcf_sr_regions_t* reg,
396     const(char)* seq,
397     hts_pos_t start,
398     hts_pos_t end);
399 
400 /*
401  *  bcf_sr_regions_flush() - calls repeatedly regs->missed_reg_handler() until
402  *  all remaining records are processed.
403  *  Returns 0 on success, <0 on error.
404  */
405 int bcf_sr_regions_flush(bcf_sr_regions_t* regs);
406