Abstract

Motivation

Tumor genome sequencing offers great promise for guiding research and therapy, but spurious variant calls can arise from multiple sources. Mouse contamination can generate many spurious calls when sequencing patient-derived xenografts. Paralogous genome sequences can also generate spurious calls when sequencing any tumor. We developed a BLAST-based algorithm, Mouse And Paralog EXterminator (MAPEX), to identify and filter out spurious calls from both these sources.

Results

When calling variants from xenografts, MAPEX has similar sensitivity and specificity to more complex algorithms. When applied to any tumor, MAPEX also automatically flags calls that potentially arise from paralogous sequences. Our implementation, mapexr, runs quickly and easily on a desktop computer. MAPEX is thus a useful addition to almost any pipeline for calling genetic variants in tumors.

Availability and implementation

The mapexr package for R is available at https://github.com/bmannakee/mapexr under the MIT license.

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

Molecular characterization of tumors is an important tool in cancer research, and the large-scale sequencing of cancer genomes has led to a deeper understanding of many aspects of the biology of cancer (Stratton, 2011). It is now common to sequence tumors from large cohorts of patients, as well as patient-derived xenograft (PDX) models from individual patients. Such sequencing enables identification of mutational signatures (Alexandrov et al., 2013), functionally important variants (Ding et al., 2012) and evolutionary history of the tumor (Carter et al., 2012; Nik-Zainal et al., 2012). These genetic features are relevant in evaluating etiological mechanisms (Yachida et al., 2010), prognostic subtypes (Park et al., 2010; Shah et al., 2009), and acquired therapeutic resistance (Witkiewicz et al., 2015). All these applications of tumor sequencing depend on sensitive and specific characterization of low-frequency mutations, and as a result may be biased by spurious variant calls. Here, we focus on two specific sources of spurious calls, mouse cell contamination in PDX tumors and mis-alignment of paralogous sequences.

PDX models serve as avatars for individual patient tumors when studying intra-tumor heterogeneity and metastasis and when screening anti-cancer compounds (Allaway et al., 2016; Bruna et al., 2016; Dawson et al., 2012; Day et al., 2015; Knudsen et al., 2017). The primary difficulty in sequencing these models is that mouse stroma is present in all PDX tumors. The high genetic similarity between mouse and human then causes bias when variants are called using bioinformatic pipelines originally developed for primary tumors (Rossello et al., 2013; Tso et al., 2014). Several methods have been developed to facilitate the accurate calling of variants in PDX models. Experimentally, human-specific fluorescence tags can be used to label and isolate human cells prior to DNA extraction (Schneeberger et al., 2016). Bioinformatically, sequence reads can be aligned to both human and mouse reference genomes, either separately (Conway et al., 2012; Khandelwal et al., 2017) or simultaneously (Bruna et al., 2016), to filter out mouse reads prior to variant calling. Although these approaches greatly improve the reliability of variant calls from PDX models, they entail substantial experimental or bioinformatic burdens. Here, we describe a light-weight filtering algorithm that achieves equivalent reliability and can be easily added to standard bioinformatic pipelines, because it uses the same reference genome for alignment as primary tumors.

Many human genes have highly similar paralogous sequences in the genome. Spurious variant calls arising from such paralogs have been recognized as an important source of false positives in the study of rare disease-associated germline variants (Jia et al., 2012; Mandelker et al., 2016; Ng et al., 2010; Zhou et al., 2015). Similarly, paralogs have led to false positives in the study of cancer, including TUBB in non-small cell lung cancer (Kelley et al., 2001), PIK3CA in hepatocellular carcinoma (Müller et al., 2007; Tanaka et al., 2006) and MLL3 in myelodysplastic syndrome (Bowler et al., 2014). To address the paralog problem, some variant callers, such as MuTect2 [currently in beta but included in the Genome Analysis Toolkit (GATK; McKenna et al., 2010)], filter clustered variants, which often result from mis-alignment of paralogous sequences. Many labs also keep lists of suspect genes that tend to suffer from paralog problems and simply ignore any variants called in these genes. These approaches introduce their own biases. Our approach automatically identifies potential spurious calls from paralogs and enables flexible evidence-based filtering.

Here, we fully describe and characterize MAPEX (the Mouse And Paralog EXterminator), a BLASTN-based algorithm for filtering variants that was previously introduced by Knudsen et al. (2017). We also present mapexr, a fast and light-weight implementation in R. The MAPEX algorithm is aimed at three use cases.

  1. Labs that sequence PDX tumors using services that align to the human reference can easily and accurately filter mouse contamination with mapexr.

  2. Bioinformatically sophisticated labs could align against both the human and mouse genomes to use other filtering approaches, but mapexr enables additional variant-level assessment of results.

  3. Any tumor genomics lab can use mapexr as a light-weight approach to identify potentially spurious variants created by paralogous sequences.

We show that, when applied to PDX samples, MAPEX generates calls that are highly similar to other methods, without the need to perform special alignments. We also show that, when applied to primary samples, MAPEX effectively filters paralogs while avoiding biases of existing heuristics. MAPEX is thus a useful addition to many tumor variant calling pipelines.

2 Approach

2.1 Workflow

The MAPEX algorithm is a post-variant-calling filter designed to fit into a standard tumor variant calling pipeline and flag variants which may arise from mis-alignment of mouse reads or from paralogous sequences (Fig. 1). The input for MAPEX is a BAM file containing tumor reads aligned to the human reference genome and a variant callset generated from that alignment. Variant-supporting reads are then BLASTed against the appropriate reference genome(s). Variants are scored by the fraction of supporting reads that align to the called site of the variant in the human genome.

Fig. 1.

Illustration of MAPEX applied to a PDX sample. MAPEX begins with variants called from tumor reads aligned to the human genome. For each variant, the supporting reads are BLASTed against the combined human and mouse reference genomes. Variants are then scored by the fraction of supporting reads that align to the called site of the variant in the human genome

2.2 Algorithm

Each read supporting a variant is BLASTed against the appropriate reference genome for the application. For PDX applications, this is the combined human/mouse reference, and for primary tumor applications, this is just the human reference. The best hit for each read is determined by bit score. Reads for which the best hit overlaps the called variant location are classified as ‘on target’ and assigned a score of 1. Reads for which the best hit is a different region of the human genome or a region of the mouse genome are classified as ‘off target’ or ‘mouse,’ respectively, and assigned a score of 0. Reads from genes with close paralogs in the human genome may generate multiple best hits (ties). In this case, the read score is averaged over all best hits, and the read is classified based on the most common result from the best hits. Each variant is then assigned a score that is the average score of all reads supporting that variant and is classified based on the most common classification of the supporting reads.

2.3 Implementation

We have implemented the MAPEX algorithm as an R package (mapexr). The package leverages the Bioconductor packages Rsamtools, GenomicAlignments and GenomicRanges for fast and memory-efficient BAM file handling and read sequence extraction (Lawrence et al., 2013; Morgan et al., 2017). The package requires a local BLASTN installation and a BLAST database constructed from either a combined human/mouse reference genome or a human reference genome, depending on the application.

3 Materials and methods

3.1 Samples

To characterize the performance of MAPEX, we used whole exome sequence trimmed fastq reads obtained from pancreatic ductal adenocarcinoma (PDAC) samples described previously by Knudsen et al. (2017) (PDX) and Witkiewicz et al. (2015) (primary). For the PDX analysis, we analyzed a total of 34 PDXs derived from 9 primary tumors, sequenced to mean coverage depth of 124x. For the paralog analysis, we analyzed 93 primary tumors sequenced to a mean coverage depth of 40x.

3.2 Alignments and variant callers

All alignments were done using bwa-mem with default parameter settings (Li and Durbin, 2009). For initial variant calling, we aligned all reads in the samples to the human reference genome GRCh37. We then called variants using MuTect version 1.1.1 (Cibulskis et al., 2013), MuTect2 (as part of the GATK version 3.6, McKenna et al., 2010) and Varscan 2 (Koboldt et al., 2012), all with default parameters. MuTect 1 and 2 variant calls were used without any post-filtering, but for Varscan 2 we used the built-in processSomatic and fpfilter functions with default parameters to generate a set of high-confidence variant calls. Variants were annotated with Oncotator (Ramos et al., 2015) and the annotation database oncotator_v1_ds_April052016. We considered only non-synonymous single nucleotide variants when comparing between methods. For paralog filtering, we used a conservative variant score cutoff of 0.8.

For comparison with Bruna et al. (2016), we aligned reads to a combined human/mouse reference genome GRCh37/mm9 and called variants using MuTect 1.1.1. We calculated the fraction of mouse contamination using the method described in Bruna et al. (2016). Briefly, they generated data comparing the fraction of mouse cells in a sample with the fraction of total reads aligned to the mouse portion of a combined reference genome. We used this data to fit a LOESS regression model for contamination fraction versus fraction aligned, and used this to predict mouse contamination based on the fraction of reads aligned to the mouse genome in our samples.

For comparison with bamcmp (Khandelwal et al., 2017), we aligned reads separately to the human and mouse reference genomes and ran bamcmp with default parameters. The output of bamcmp includes alignment files for reads that aligned to only the human reference and that aligned to both references but with a higher human alignment score. We merged these two alignments, performed indel re-alignment and base score re-calibration using the GATK, and used the merged alignment to call variants with Mutect version 1.1.1. All scripts (doi: 10.5281/zenodo.1112101) and the version of mapexr (doi: 10.5281/zenodo.1112234) used to conduct the analysis have been archived with Zenodo.

4 Results and discussion

4.1 Methodological

MAPEX is a light-weight filtering algorithm that adds little overhead or complexity to existing tumor variant-calling pipelines. The runtime for mapexr is linear in the number of variants to be filtered, processing roughly 250 variants per minute on a 4-core machine (Supplementary Fig. S1).

MAPEX has only one tunable parameter, the minimum mapping quality score required for a variant read. The default minimum score is 1, which includes all reads with an unambiguous best mapping. In pipelines in which a minimum mapping quality score is used for variant calling, that score should also be supplied to mapexr, to prevent evaluating reads that were not used by the variant caller. The output from mapexr is an R data frame with four columns—chromosome, start location, variant score and variant classification—and one row for each variant evaluated. Users may also optionally provide a file path to mapexr which will generate a tab-delimited file with BLAST results and scores at the read level. The user can choose the variant score threshold used to classify variants as human- or mouse-derived. Here, we use a threshold of 0.5, so that a variant is flagged as spurious if less than half of the supporting reads BLAST as ‘on target.’ In practice, the distribution of variant scores is bimodal and highly concentrated at 0 and 1, so results are insensitive to the exact threshold (Supplementary Fig. S2).

4.2 Filtering mouse calls from PDX samples

One important use case for MAPEX is as a post-variant-calling filter for PDX samples that have been aligned to a human reference genome. To test the precision of MAPEX, we compared variant calls from aligning reads to the human reference and filtering with MAPEX to calls from two other methods. The first alternate method is to align reads to a combined human and mouse reference and then call variants (Bruna et al., 2016), which we refer to as the ‘combined reference’ method. This requires similar CPU time to using MAPEX. The second method is to align reads separately to human and mouse references and call variants using only those reads that align better to the human reference, which is the method implemented in bamcmp (Khandelwal et al., 2017). This requires twice as much CPU time for alignment as MAPEX, and the post-alignment step is typically shorter for MAPEX, although it can be longer for samples with very high mouse contamination (Supplementary Fig. S3). For three representative PDX tumors, all three methods yield similar callsets (Fig. 2A). The differences are primarily confined to low-frequency variants, and almost all high-frequency variants are called by all three methods (Fig. 2B). MAPEX might reduce power to identify low-frequency subclonal variants, if some of the few reads supporting a variant BLASTed to incorrect locations. This would yield an intermediate variant score. Because variant scores are strongly bimodal (Supplementary Fig. S2), we expect that MAPEX causes little to no reduction in power. Across 34 PDX tumors, all three methods yield a similar dramatic reduction in called variants (Fig. 2C).

Fig. 2.

Comparison of MuTect 1.1.1 variants calls between MAPEX, combined reference, and bamcmp methods. (A) Detailed breakdown of variant call overlap between the unfiltered human alignment (squares), MAPEX filtered human alignment (right circles), bamcmp filtered human alignment (top circles) and unfiltered combined alignment (bottom circles) for representative PDXs created from three different primary tumors. (B) Variant allele frequencies for calls in 34 PDX samples that are concordant (n = 1663 variants) and discordant (n = 552 variants) between the methods. (C) Comparison of total calls between the methods, n = 34 PDX samples. Boxplots depict 25th and 75th percentile with 1.5 × IQR whiskers. Notches are Median ± 1.58 × IQR/sqrt(n), and represent rough estimates of 95% confidence interval around the median

To further validate MAPEX, we compared PDX variant calls before and after filtering to the primary tumor from which the PDX was derived, where mouse contamination is not an issue. Across 34 PDX tumors derived from 9 primaries, MAPEX dramatically enriches PDX calls for variants that were also found in the primary tumor and removes few PDX calls that were found in the primary tumor. Among variants in the PDXs, only 0.3% to 10% called before MAPEX filtering were also found in the primary tumor, but 23% to 90% of variants called after MAPEX filtering were found in the primary tumor (Supplementary Table S1). This suggests that MAPEX enriches strongly for true variants. Among variants found both in the primary after MAPEX filtering and in the PDX before MAPEX filtering, 97% to 100% were retained in the PDX after MAPEX filtering (Supplementary Table S1). Only one variant identified in each of two primary tumors was filtered by mapexr in a derived PDX. In primary tumor EMC1222, only 60% (slightly above the 50% cutoff) of variant reads mapped on-target for the primary variant (suggesting that it may be a spurious variant caused by a paralogous sequence), while in the PDXs only 20–45% (slightly below the cutoff) of variant reads mapped on-target. In EMC226, the variant appears to be from human wild-type to mouse wild-type, so 55% of variant reads (in a PDX with 57% mouse contamination), mapped to the mouse genome. Together these results suggest that MAPEX removes few true variants.

To validate the usefulness of MAPEX in practice, we focused on calls within known cancer-associated genes, using the COSMIC database. Among the PDAC samples in COSMIC, 34 genes are mutated in more than 3% of samples. Before filtering with MAPEX, 910 variants were found in these genes among the 34 PDXs we studied. After filtering with MAPEX, only 70 variants were retained. These results suggest that MAPEX removes many false positives, dramatically simplifying variant interpretation. Of particular interest are KRAS, TP53 and SMAD4, which are the most commonly mutated genes in PDAC (Table 1). All of the KRAS mutations filtered by MAPEX are I187V mutants, which result from aligning wild-type mouse KRAS reads to human KRAS, and all 34 PDXs retained the KRAS mutation found in their primary tumor. All of the SMAD4 and TP53 mutations that were retained by MAPEX in the PDXs also appeared in the corresponding primary tumors, and all of those filtered were not found in the corresponding primary tumors. ARID1A is particularly susceptible to spurious variants caused by mouse contamination; only one of the 131 variants originally called in ARID1A was retained by MAPEX. We confirmed that the single retained variant was found in the primary tumor from which the PDX was derived, while none of the 130 rejected variants were found in their corresponding primaries.

Table 1.

Variants detected in PDX samples for important PDAC genes

Genebefore MAPEXafter MAPEX
TotalSamples withTotalCOSMIC
variantsa variantvariantsprevalence
KRAS5634340.64
TP539970.39
SMAD45550.14
SYNE13300.05
CSMD3962500.05
GNAS6660.05
HMCN110500.04
APC121100.04
NEB311700.04
WDFY46410.04
LRP1B321810.04
ARID1A1313310.04
Genebefore MAPEXafter MAPEX
TotalSamples withTotalCOSMIC
variantsa variantvariantsprevalence
KRAS5634340.64
TP539970.39
SMAD45550.14
SYNE13300.05
CSMD3962500.05
GNAS6660.05
HMCN110500.04
APC121100.04
NEB311700.04
WDFY46410.04
LRP1B321810.04
ARID1A1313310.04
Table 1.

Variants detected in PDX samples for important PDAC genes

Genebefore MAPEXafter MAPEX
TotalSamples withTotalCOSMIC
variantsa variantvariantsprevalence
KRAS5634340.64
TP539970.39
SMAD45550.14
SYNE13300.05
CSMD3962500.05
GNAS6660.05
HMCN110500.04
APC121100.04
NEB311700.04
WDFY46410.04
LRP1B321810.04
ARID1A1313310.04
Genebefore MAPEXafter MAPEX
TotalSamples withTotalCOSMIC
variantsa variantvariantsprevalence
KRAS5634340.64
TP539970.39
SMAD45550.14
SYNE13300.05
CSMD3962500.05
GNAS6660.05
HMCN110500.04
APC121100.04
NEB311700.04
WDFY46410.04
LRP1B321810.04
ARID1A1313310.04

4.3 Effects of variant call filters on PDXs

We carried out our primary analyses with the variant caller MuTect 1.1.1, but to test the performance of MAPEX with other variants callers, we also considered MuTect2 and Varscan 2.

If mouse contamination were perfectly filtered, the number of called variants should not depend on the level of mouse contamination. For all three variant callers the number of raw calls was strongly correlated with estimated mouse contamination (Fig. 3A–C), although MuTect2 and Varscan2 did produce substantially fewer calls overall than MuTect 1. After filtering with MAPEX, the numbers of variants called by all three callers was not significantly correlated with the level of mouse contamination (Fig. 3D–F).

Fig. 3.

Effects of variant caller on analyzing xenograft samples with MAPEX. (AC) For all three calling algorithms and 34 xenograft samples (black dots), the number of raw variants called was strongly dependent on estimated mouse contamination. (DF) After filtering with MAPEX, the number of calls was independent of mouse contamination for all three callers. Lines show linear regressions and shading denotes 95% confidence intervals

Importantly, as a post-variant-calling filter, MAPEX can not evaluate variants that were not initially called. Filters implemented with a variant caller, generally designed to improve results from primary tumors, can cause problems when using MAPEX. For example, MuTect2 applies a clustered event filter designed to reduce the number of false-positive variant calls due to mis-alignment of highly paralogous sequences. In regions of high similarity between mouse and human, this filter can remove true variants. For instance, Figure 4 shows the result of aligning a PDX with modest mouse contamination to the human reference for a small portion of the KRAS oncogene. MuTect 1.1.1 and Varscan 2 both called three variants at this locus, and MAPEX correctly rejected the two spurious variants arising from mouse contamination and retained the true G12D variant. MuTect2 fails to call any of these variants, because they are filtered as likely homologous mapping events, so MAPEX does not see and cannot retain the true G12D variant. In our PDX samples, we found instances of the clustered event filter removing true variants from other PDAC oncogenes, including SMAD4 and TP53.

Fig. 4.

This Integrative Genomics Viewer (Thorvaldsdóttir et al., 2013) window covers a portion of the human KRAS gene. The C > T variant is the classic KRAS G12D mutation that appears in many PDAC tumors. The A > G and T > C variants both result from aligning wild-type mouse reads to the human sequence. When used with MuTect 1.1.1 or Varscan 2, MAPEX correctly retains only the G12D variant. MuTect2, however, filters all three variants, so the G12D variant cannot be retained

Overall, the performance of MAPEX does not depend sensitively on the variant caller used, but callers can introduce specific biases. In particular, the default parameters for Varscan 2 yield high sensitivity but low specificity, so the use of the built-in post-call variant filters is necessary to prevent excessive false positives (Supplementary Fig. S4). In contrast, the default parameters for MuTect2 yield much higher specificity, but at the cost of sensitivity in the PDX context. Currently, the clustered event filter cannot be disabled in MuTect2. We thus advise that users pairing MAPEX with MuTect2 be cautious when interpreting callsets from PDX samples in genes with high similarity between human and mouse.

4.4 Flagging potential false positives resulting from paralogous sequences

In addition to removing mouse contamination from PDX samples, MAPEX can also filter potential paralogs in primary samples. Across 93 PDAC primary tumors, a mean of 11% of total variant calls were flagged by MAPEX as potential paralogs, with a range of 2–33%. The genes in which variants were most frequently flagged as potentially arising from paralogous sequences include members of large gene families, such as mucins, zinc-finger nucleases and the PRAME family (Table 2). Variants in citrate synthase (CS) were also frequently flagged (Table 2). CS has a known pseudogene NCBI: LOC440514 that was responsible for all of the spurious calls. We called variants with MuTect 1.1.1 and filtered with MAPEX, but MuTect2 includes new clustered event and read-mapping quality filters to prevent calling variants caused by paralogs. Using MAPEX yielded call sets that were identical with MuTect2 for all the genes in Table 2, with the exception of MUC12 and MUC5B, which differed by three variants. MAPEX can thus be efficiently and confidently used to remove variants that likely arise from paralogous sequences, with the additional benefit that the reason for classifying a variant as a potential paralog, as well as the genomic locations of the paralogous sequences, can be investigated.

Table 2.

Top genes for which MAPEX flagged variants as potentially arising from paralogs

GeneVariantsSamples with
flaggeda flagged variant
ZNF8141515
CS127
IGFN186
KMT2C77
FRG166
LILRB366
MUC1266
RGPD366
USP663
FCGBP54
MUC5B55
NBPF153
PRAMEF1154
PRB453
RGPD854
GeneVariantsSamples with
flaggeda flagged variant
ZNF8141515
CS127
IGFN186
KMT2C77
FRG166
LILRB366
MUC1266
RGPD366
USP663
FCGBP54
MUC5B55
NBPF153
PRAMEF1154
PRB453
RGPD854
Table 2.

Top genes for which MAPEX flagged variants as potentially arising from paralogs

GeneVariantsSamples with
flaggeda flagged variant
ZNF8141515
CS127
IGFN186
KMT2C77
FRG166
LILRB366
MUC1266
RGPD366
USP663
FCGBP54
MUC5B55
NBPF153
PRAMEF1154
PRB453
RGPD854
GeneVariantsSamples with
flaggeda flagged variant
ZNF8141515
CS127
IGFN186
KMT2C77
FRG166
LILRB366
MUC1266
RGPD366
USP663
FCGBP54
MUC5B55
NBPF153
PRAMEF1154
PRB453
RGPD854

5 Conclusion

Genome sequencing is an increasingly important tool in cancer research, but spurious variant calls remain a challenge. MAPEX is an algorithm designed to filter spurious variants caused by mouse reads in PDXs and caused by paralogous sequences in primary tumors. We showed that MAPEX is as sensitive and specific as more computationally intensive methods for calling variants from PDX tumors. We also showed that MAPEX successfully flags variant calls in potentially problematic gene families in primary tumors. Our implementation, mapexr, fits cleanly into standard tumor variant-calling pipelines and runs quickly on modern desktop computers. MAPEX is thus a potentially useful new component for many tumor variant-calling pipelines.

Funding

This work was supported by the National Science Foundation via Graduate Research Fellowship DGE-1143953 to BKM and by the National Institutes of Health via grants R01CA211878-01 and P30CA023074-36S2 to AKW and ESK.

Conflict of Interest: none declared.

References

Alexandrov
 
L.B.
 et al.  (
2013
)
Signatures of mutational processes in human cancer
.
Nature
,
500
,
415
421
.

Allaway
 
R.J.
 et al.  (
2016
)
Genomic characterization of patient-derived xenograft models established from fine needle aspirate biopsies of a primary pancreatic ductal adenocarcinoma and from patient-matched metastatic sites
.
Oncotarget
,
7
,
17087
17102
.

Bowler
 
T.G.
 et al.  (
2014
)
Exome sequencing of familial MDS reveals novel mutations and high rates of false positive mutations in MLL3 due to pseudogene effects
.
Blood
,
124
,
4591
.

Bruna
 
A.
 et al.  (
2016
)
A biobank of breast cancer explants with preserved intra-tumor heterogeneity to screen anticancer compounds
.
Cell
,
167
,
260
274
.

Carter
 
S.L.
 et al.  (
2012
)
Absolute quantification of somatic DNA alterations in human cancer
.
Nat. Biotechnol
.,
30
,
413
421
.

Cibulskis
 
K.
 et al.  (
2013
)
Sensitive detection of somatic point mutations in impure and heterogeneous cancer samples
.
Nat. Biotechnol
.,
31
,
213
219
.

Conway
 
T.
 et al.  (
2012
)
Xenome–a tool for classifying reads from xenograft samples
.
Bioinformatics
,
28
,
i172
i178
.

Dawson
 
C.W.
 et al.  (
2012
)
The role of the EBV-encoded latent membrane proteins LMP1 and LMP2 in the pathogenesis of nasopharyngeal carcinoma (NPC)
.
Sem. Cancer Biol
.,
22
,
144
153
.

Day
 
C.-P.
 et al.  (
2015
)
Preclinical mouse cancer models: a maze of opportunities and challenges
.
Cell
,
163
,
39
53
.

Ding
 
L.
 et al.  (
2012
)
Clonal evolution in relapsed acute myeloid leukaemia revealed by whole-genome sequencing
.
Nature
,
481
,
506
510
.

Jia
 
P.
 et al.  (
2012
)
Consensus rules in variant detection from next-generation sequencing data
.
PLoS One
,
7
,
e38470
.

Kelley
 
M.J.
 et al.  (
2001
)
Genetic analysis of the beta-tubulin gene, TUBB, in non-small-cell lung cancer
.
J. Natl. Cancer Inst
.,
93
,
1886
1888
.

Khandelwal
 
G.
 et al.  (
2017
)
Next-gen sequencing analysis and algorithms for PDX and CDX models
.
Mol. Cancer Res
.,
8
,
1012
1016
.

Knudsen
 
E.S.
 et al.  (
2017
).
Pancreatic cancer cell lines as patient-derived avatars: genetic characterisation and functional utility
.
Gut
, gutjnl–2016–313133.

Koboldt
 
D.C.
 et al.  (
2012
)
VarScan 2: somatic mutation and copy number alteration discovery in cancer by exome sequencing
.
Genome Res
.,
22
,
568
576
.

Lawrence
 
M.
 et al.  (
2013
)
Software for computing and annotating genomic ranges
.
PLoS Comput. Biol
.,
9
,
1–10
.

Li
 
H.
,
Durbin
R.
(
2009
)
Fast and accurate short read alignment with Burrows-Wheeler transform
.
Bioinformatics (Oxford, England)
,
25
,
1754
1760
.

Mandelker
 
D.
 et al.  (
2016
)
Navigating highly homologous genes in a molecular diagnostic setting: a resource for clinical next-generation sequencing
.
Genetics Med
.,
18
,
1
8
.

McKenna
 
A.
 et al.  (
2010
)
The Genome Analysis Toolkit: a MapReduce framework for analyzing next-generation DNA sequencing data
.
Genome Res
.,
20
,
1297
1303
.

Morgan
 
M.
 et al.  (
2017
) Rsamtools: binary alignment (BAM), FASTA, variant call (BCF), and tabix file import. R package version 1.30.0, http://bioconductor.org/packages/release/bioc/html/Rsamtools.html.

Müller
 
C.I.
 et al.  (
2007
)
Rare mutations of the PIK3CA gene in malignancies of the hematopoietic system as well as endometrium, ovary, prostate and osteosarcomas, and discovery of a PIK3CA pseudogene
.
Leukemia Res
.,
31
,
27
32
.

Ng
 
S.B.
 et al.  (
2010
)
Massively parallel sequencing and rare disease
.
Human Mol. Genetics
,
19
,
119
124
.

Nik-Zainal
 
S.
 et al.  and
Breast Cancer Working Group of the International Cancer Genome Consortium
. (
2012
)
The life history of 21 breast cancers
.
Cell
,
149
,
994
1007
.

Park
 
S.Y.
 et al.  (
2010
)
Cellular and genetic diversity in the progression of in situ human breast carcinomas to an invasive phenotype
.
J. Clin. Investig
.,
120
,
636
644
.

Ramos
 
A.H.
 et al.  (
2015
)
Oncotator: cancer variant annotation tool
.
Human Mutation
,
36
,
E2423
E2429
.

Rossello
 
F.J.
 et al.  (
2013
)
Next-generation sequence analysis of cancer xenograft models
.
PLoS One
,
8
,
e74432
.

Schneeberger
 
V.E.
 et al.  (
2016
)
Quantitation of murine stroma and selective purification of the human tumor component of patient-derived xenografts for genomic analysis
.
PLoS One
,
11
,
e0160587
.

Shah
 
S.P.
 et al.  (
2009
)
Mutational evolution in a lobular breast tumour profiled at single nucleotide resolution
.
Nature
,
461
,
809
813
.

Stratton
 
M.R.
(
2011
)
Exploring the genomes of cancer cells: progress and promise
.
Science
,
331
,
1553
1558
.

Tanaka
 
Y.
 et al.  (
2006
)
Absence of PIK3CA hotspot mutations in hepatocellular carcinoma in Japanese patients
.
Oncogene
,
25
,
2950
2952
.

Thorvaldsdóttir
 
H.
 et al.  (
2013
)
Integrative Genomics Viewer (IGV): high-performance genomics data visualization and exploration
.
Brief. Bioinformatics
,
14
,
178
192
.

Tso
 
K.-Y.
 et al.  (
2014
)
Are special read alignment strategies necessary and cost-effective when handling sequencing reads from patient-derived tumor xenografts?
BMC Genomics
,
15
,
1172
.

Witkiewicz
 
A.K.
 et al.  (
2015
)
Whole-exome sequencing of pancreatic cancer defines genetic diversity and therapeutic targets
.
Nat. Commun
.,
6
,
6744
.

Yachida
 
S.
 et al.  (
2010
)
Distant metastasis occurs late during the genetic evolution of pancreatic cancer
.
Nature
,
467
,
1114
1117
.

Zhou
 
W.
 et al.  (
2015
)
ClinSeK: a targeted variant characterization framework for clinical sequencing
.
Genome Med
.,
7
,
34
.

This article is published and distributed under the terms of the Oxford University Press, Standard Journals Publication Model (https://academic.oup.com/journals/pages/about_us/legal/notices)
Associate Editor: John Hancock
John Hancock
Associate Editor
Search for other works by this author on:

Supplementary data