本文整理汇总了C++中bamtools::BamAlignment::IsReverseStrand方法的典型用法代码示例。如果您正苦于以下问题:C++ BamAlignment::IsReverseStrand方法的具体用法?C++ BamAlignment::IsReverseStrand怎么用?C++ BamAlignment::IsReverseStrand使用的例子?那么, 这里精选的方法代码示例或许可以为您提供帮助。您也可以进一步了解该方法所在类bamtools::BamAlignment
的用法示例。
在下文中一共展示了BamAlignment::IsReverseStrand方法的6个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于系统推荐出更棒的C++代码示例。
示例1: TrackReadsOnRegion
void RegionCoverage::TrackReadsOnRegion( const BamTools::BamAlignment &aread, uint32_t endPos )
{
// track total and on-target reads
uint32_t readEnd = endPos ? endPos : aread.GetEndPosition();
uint32_t covType = ReadOnRegion( aread.RefID, aread.Position + 1, readEnd );
TargetContig *contig = m_contigList[m_rcovContigIdx];
if( aread.IsReverseStrand() ) {
++contig->fwdReads;
if( covType & 1 ) ++contig->fwdTrgReads;
} else {
++contig->revReads;
if( covType & 1 ) ++contig->revTrgReads;
}
}
示例2: insertRead
void bamParser::insertRead(const BamTools::BamAlignment& read, Reads& reads,
string& chr) {
int32_t loc = read.Position;
bool dir;
dir = (read.IsReverseStrand() ? false : true);
if (loc > 0) {
uint32_t tmp = (uint32_t) loc;
if (dir) {
reads.pos_reads.insertRead(chr, tmp);
} else {
reads.neg_reads.insertRead(chr, tmp);
}
}
}
示例3: getVariantCoverage
CoverageStats getVariantCoverage(BamTools::BamReader* pReader, const VCFRecord& record, const ReadTable* refTable)
{
CoverageStats stats;
static const int flankingSize = 100;
static const double minPercentIdentity = 95.0f;
bool is_snv = record.refStr.size() == 1 && record.varStr.size() == 1;
// Grab the reference haplotype
int eventLength = record.varStr.length();
int zeroBasedPos = record.refPosition - 1;
int start = zeroBasedPos - flankingSize - 1;
if(start < 0)
start = 0;
int end = zeroBasedPos + eventLength + 2 * flankingSize;
const SeqItem& chr = refTable->getRead(record.refName);
if(end > (int)chr.seq.length())
end = (int)chr.seq.length();
std::string reference_haplotype = chr.seq.substr(start, end - start);
int translatedPos = zeroBasedPos - start;
std::string variant_haplotype = reference_haplotype;
// Ensure that the reference string at the variant matches the expected
assert(variant_haplotype.substr(translatedPos, record.refStr.length()) == record.refStr);
variant_haplotype.replace(translatedPos, record.refStr.length(), record.varStr);
// Grab all reads in reference region
int refID = pReader->GetReferenceID(record.refName);
if(refID < 0)
return stats;
int refStart = record.refPosition;
int refEnd = record.refPosition;
pReader->SetRegion(refID, refStart, refID, refEnd);
BamTools::BamAlignment aln;
std::vector<double> mapping_quality;
std::vector<BamTools::BamAlignment> alignments;
while(pReader->GetNextAlignment(aln)) {
if(aln.MapQuality > 0)
alignments.push_back(aln);
mapping_quality.push_back(aln.MapQuality);
}
if(!mapping_quality.empty())
stats.median_mapping_quality = median(mapping_quality);
else
stats.median_mapping_quality = 60;
// Shuffle and take the first 200 alignments only
std::random_shuffle(alignments.begin(), alignments.end());
for(size_t i = 0; i < alignments.size() && i < opt::capAlignments; ++i) {
BamTools::BamAlignment alignment = alignments[i];
VariantReadSegments segments = splitReadAtVariant(alignment, record);
if(opt::verbose > 1)
{
fprintf(stderr, "var: %zu %s -> %s\n", record.refPosition, record.refStr.c_str(), record.varStr.c_str());
fprintf(stderr, "pos: %d\n", alignment.Position);
fprintf(stderr, "strand: %s\n", alignment.IsReverseStrand() ? "-" : "+");
fprintf(stderr, "read: %s\n", alignment.QueryBases.c_str());
fprintf(stderr, "qual: %s\n", alignment.Qualities.c_str());
fprintf(stderr, "alnb: %s\n", alignment.AlignedBases.c_str());
fprintf(stderr, "Pre: %s\n", segments.preSegment.c_str());
fprintf(stderr, "Var: %s\n", segments.variantSegment.c_str());
fprintf(stderr, "Pos: %s\n", segments.postSegment.c_str());
fprintf(stderr, "PreQual: %s\n", segments.preQual.c_str());
fprintf(stderr, "VarQual: %s\n", segments.variantQual.c_str());
fprintf(stderr, "PosQual: %s\n", segments.postQual.c_str());
}
bool aligned_at_variant = segments.variantSegment.size() > 0 &&
(segments.preSegment.size() > 0 || segments.postSegment.size() > 0);
if(!aligned_at_variant)
continue;
stats.n_total_reads += 1;
if(segments.variantSegment == record.refStr)
continue; // not an evidence read
// Align the read to the reference and variant haplotype
SequenceOverlap ref_overlap = Overlapper::computeOverlapAffine(alignment.QueryBases, reference_haplotype);
SequenceOverlap var_overlap = Overlapper::computeOverlapAffine(alignment.QueryBases, variant_haplotype);
bool quality_alignment = (ref_overlap.getPercentIdentity() >= minPercentIdentity ||
var_overlap.getPercentIdentity() >= minPercentIdentity);
bool is_evidence_read = quality_alignment && var_overlap.score > ref_overlap.score;
if(is_evidence_read)
{
//.........这里部分代码省略.........
示例4: ParseRead
bool ReadContainer::ParseRead(const BamTools::BamAlignment& aln,
AlignedRead* aligned_read,
map<pair<string,int>, string>& ref_ext_nucleotides) {
// get read ID
aligned_read->ID = aln.Name;
// get nucleotides
aligned_read->nucleotides = aln.QueryBases;
// get qualities
aligned_read->qualities = aln.Qualities;
// get strand
aligned_read->strand = aln.IsReverseStrand();
// get chrom
aligned_read->chrom = references.at(aln.RefID).RefName;
// get read start
aligned_read->read_start = aln.Position;
// get cigar
aligned_read->cigar_ops = aln.CigarData;
// get if mate pair
if (aln.IsSecondMate()) {
aligned_read->mate = 1;
} else {
aligned_read->mate = 0;
}
// Only process if it is the primary alignment
if (aligned_read->mate) {
return false;
}
// Get all the tag data
// don't process if partially spanning (from old lobSTR)
int partial = 0;
if (GetIntBamTag(aln, "XP", &partial)) {
if (partial == 1) return false;
}
// get read group
if (!GetStringBamTag(aln, "RG", &aligned_read->read_group)) {
stringstream msg;
msg << aln.Name << " Could not get read group.";
PrintMessageDieOnError(msg.str(), ERROR);
}
// get msStart
if (!GetIntBamTag(aln, "XS", &aligned_read->msStart)) {
stringstream msg;
msg << aln.Name << " from group " << aligned_read->read_group << " Could not get STR start coordinate. Did this bam file come from lobSTR?";
PrintMessageDieOnError(msg.str(), ERROR);
}
// get msEnd
if (!GetIntBamTag(aln, "XE", &aligned_read->msEnd)) {
stringstream msg;
msg << aln.Name << " from group " << aligned_read->read_group << " Could not get STR end coordinate. Did this bam file come from lobSTR?";
PrintMessageDieOnError(msg.str(), ERROR);
}
// get mapq. Try unsigned/signed
if (!GetIntBamTag(aln, "XQ", &aligned_read->mapq)) {
stringstream msg;
aligned_read->mapq = 0;
}
// get diff
if (!GetIntBamTag(aln, "XD", &aligned_read->diffFromRef)) {
return false;
}
// get mate dist
if (!GetIntBamTag(aln, "XM", &aligned_read->matedist)) {
aligned_read->matedist = 0;
}
// get STR seq
if (!GetStringBamTag(aln, "XR", &aligned_read->repseq)) {
stringstream msg;
msg << aln.Name << " from group " << aligned_read->read_group << " Could not get repseq.";
PrintMessageDieOnError(msg.str(), ERROR);
}
// get if stitched
if (!GetIntBamTag(aln, "XX", &aligned_read->stitched)) {
aligned_read->stitched = 0;
}
// get ref copy num
if (!GetFloatBamTag(aln, "XC", &aligned_read->refCopyNum)) {
stringstream msg;
msg << aln.Name << " from group " << aligned_read->read_group << " Could not get reference copy number.";
PrintMessageDieOnError(msg.str(), ERROR);
}
// get period
aligned_read->period = aligned_read->repseq.length();
if (include_flank) { // diff is just sum of differences in cigar
CIGAR_LIST cigar_list;
for (vector<BamTools::CigarOp>::const_iterator
it = aligned_read->cigar_ops.begin();
it != aligned_read->cigar_ops.end(); it++) {
CIGAR cig;
cig.num = (*it).Length;
cig.cigar_type = (*it).Type;
cigar_list.cigars.push_back(cig);
}
bool added_s;
bool cigar_had_s;
cigar_list.ResetString();
GenerateCorrectCigar(&cigar_list, aln.QueryBases,
&added_s, &cigar_had_s);
aligned_read->diffFromRef = GetSTRAllele(cigar_list);
}
// apply filters
//.........这里部分代码省略.........
示例5: filterByGraph
// Returns true if the paired reads are a short-insert pair
bool filterByGraph(StringGraph* pGraph,
const BamTools::RefVector& referenceVector,
BamTools::BamAlignment& record1,
BamTools::BamAlignment& record2)
{
std::string vertexID1 = referenceVector[record1.RefID].RefName;
std::string vertexID2 = referenceVector[record2.RefID].RefName;
// Get the vertices for this pair using the mapped IDs
Vertex* pX = pGraph->getVertex(vertexID1);
Vertex* pY = pGraph->getVertex(vertexID2);
// Ensure that the vertices are found
assert(pX != NULL && pY != NULL);
#ifdef DEBUG_CONNECT
std::cout << "Finding path from " << vertexID1 << " to " << vertexID2 << "\n";
#endif
EdgeDir walkDirectionXOut = ED_SENSE;
EdgeDir walkDirectionYIn = ED_SENSE;
// Flip walk directions if the alignment is to the reverse strand
if(record1.IsReverseStrand())
walkDirectionXOut = !walkDirectionXOut;
if(record2.IsReverseStrand())
walkDirectionYIn = !walkDirectionYIn;
int fromX = walkDirectionXOut == ED_SENSE ? record1.Position : record1.GetEndPosition();
int toY = walkDirectionYIn == ED_SENSE ? record2.Position : record2.GetEndPosition();
// Calculate the amount of contig X that already covers the fragment
// Using this number, we calculate how far we should search
int coveredX = walkDirectionXOut == ED_SENSE ? pX->getSeqLen() - fromX : fromX;
int maxWalkDistance = opt::maxDistance - coveredX;
bool bShortInsertPair = false;
if(pX == pY)
{
if(abs(record1.InsertSize) < opt::maxDistance)
bShortInsertPair = true;
}
else
{
SGWalkVector walks;
SGSearch::findWalks(pX, pY, walkDirectionXOut, maxWalkDistance, 10000, true, walks);
if(!walks.empty())
{
for(size_t i = 0; i < walks.size(); ++i)
{
std::string fragment = walks[i].getFragmentString(pX,
pY,
fromX,
toY,
walkDirectionXOut,
walkDirectionYIn);
if((int)fragment.size() < opt::maxDistance)
{
bShortInsertPair = true;
//std::cout << "Found completing fragment (" << pX->getID() << " -> " << pY->getID() << ": " << fragment.size() << "\n";
break;
}
}
}
}
return bShortInsertPair;
}
示例6: BaseHypothesisEvaluator
// Function to fill in predicted signal values
void BaseHypothesisEvaluator(BamTools::BamAlignment &alignment,
const string &flow_order_str,
const string &alt_base_hyp,
float &delta_score,
float &fit_score,
int heavy_verbose) {
// --- Step 1: Initialize Objects and retrieve relevant tags
delta_score = 1e5;
fit_score = 1e5;
vector<string> Hypotheses(2);
vector<float> measurements, phase_params;
int start_flow, num_flows, prefix_flow=0;
if (not GetBamTags(alignment, flow_order_str.length(), measurements, phase_params, start_flow))
return;
num_flows = measurements.size();
ion::FlowOrder flow_order(flow_order_str, num_flows);
BasecallerRead master_read;
master_read.SetData(measurements, flow_order.num_flows());
TreephaserLite treephaser(flow_order);
treephaser.SetModelParameters(phase_params[0], phase_params[1]);
// --- Step 2: Solve beginning of the read
// Look at mapped vs. unmapped reads in BAM
Hypotheses[0] = alignment.QueryBases;
Hypotheses[1] = alt_base_hyp;
// Safety: reverse complement reverse strand reads in mapped bam
if (alignment.IsMapped() and alignment.IsReverseStrand()) {
RevComplementInPlace(Hypotheses[0]);
RevComplementInPlace(Hypotheses[1]);
}
prefix_flow = GetMasterReadPrefix(treephaser, flow_order, start_flow, Hypotheses[0], master_read);
unsigned int prefix_size = master_read.sequence.size();
// --- Step 3: creating predictions for the individual hypotheses
vector<BasecallerRead> hypothesesReads(Hypotheses.size());
vector<float> squared_distances(Hypotheses.size(), 0.0);
int max_last_flow = 0;
for (unsigned int i_hyp=0; i_hyp<hypothesesReads.size(); ++i_hyp) {
hypothesesReads[i_hyp] = master_read;
// --- add hypothesis sequence to clipped prefix
unsigned int i_base = 0;
int i_flow = prefix_flow;
while (i_base<Hypotheses[i_hyp].length() and i_base<(2*(unsigned int)flow_order.num_flows()-prefix_size)) {
while (i_flow < flow_order.num_flows() and flow_order.nuc_at(i_flow) != Hypotheses[i_hyp][i_base])
i_flow++;
if (i_flow < flow_order.num_flows() and i_flow > max_last_flow)
max_last_flow = i_flow;
if (i_flow >= flow_order.num_flows())
break;
// Add base to sequence only if it fits into flow order
hypothesesReads[i_hyp].sequence.push_back(Hypotheses[i_hyp][i_base]);
i_base++;
}
i_flow = min(i_flow, flow_order.num_flows()-1);
// Solver simulates beginning of the read and then fills in the remaining clipped bases for which we have flow information
treephaser.Solve(hypothesesReads[i_hyp], num_flows, i_flow);
}
// Compute L2-distance of measurements and predictions
for (unsigned int i_hyp=0; i_hyp<hypothesesReads.size(); ++i_hyp) {
for (int iFlow=0; iFlow<=max_last_flow; iFlow++)
squared_distances[i_hyp] += (measurements.at(iFlow) - hypothesesReads[i_hyp].prediction.at(iFlow)) *
(measurements.at(iFlow) - hypothesesReads[i_hyp].prediction.at(iFlow));
}
// Delta: L2-distance of alternative base Hypothesis - L2-distance of bases as called
delta_score = squared_distances.at(1) - squared_distances.at(0);
fit_score = min(squared_distances.at(1), squared_distances.at(0));
// --- verbose ---
if (heavy_verbose > 1 or (delta_score < 0 and heavy_verbose > 0)) {
cout << "Processed read " << alignment.Name << endl;
cout << "Delta Fit: " << delta_score << " Overall Fit: " << fit_score << endl;
PredictionGenerationVerbose(Hypotheses, hypothesesReads, phase_params, flow_order, start_flow, prefix_size);
}
}