提交 09d9b61d 编写于 作者: Y YangZhou

fix copyright && refactor kaldi_feature

上级 ddc16199
...@@ -3,6 +3,7 @@ import warnings ...@@ -3,6 +3,7 @@ import warnings
from functools import wraps from functools import wraps
from typing import Optional from typing import Optional
#code is from https://github.com/pytorch/audio/blob/main/torchaudio/_internal/module_utils.py
def is_module_available(*modules: str) -> bool: def is_module_available(*modules: str) -> bool:
r"""Returns if a top-level module with :attr:`name` exists *without** r"""Returns if a top-level module with :attr:`name` exists *without**
......
...@@ -6,6 +6,7 @@ from typing import Union ...@@ -6,6 +6,7 @@ from typing import Union
from paddle import Tensor from paddle import Tensor
#code is from: https://github.com/pytorch/audio/blob/main/torchaudio/backend/no_backend.py
def load( def load(
filepath: Union[str, Path], filepath: Union[str, Path],
......
...@@ -7,6 +7,7 @@ from typing import Union ...@@ -7,6 +7,7 @@ from typing import Union
from paddle import Tensor from paddle import Tensor
#https://github.com/pytorch/audio/blob/main/torchaudio/backend/sox_io_backend.py
def load( def load(
filepath: Union[str, Path], filepath: Union[str, Path],
......
"""Defines utilities for switching audio backends""" """Defines utilities for switching audio backends"""
#code is from: https://github.com/pytorch/audio/blob/main/torchaudio/backend/utils.py
import warnings import warnings
from typing import List from typing import List
from typing import Optional from typing import Optional
......
...@@ -11,8 +11,13 @@ ...@@ -11,8 +11,13 @@
# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. # WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
# See the License for the specific language governing permissions and # See the License for the specific language governing permissions and
# limitations under the License. # limitations under the License.
from paddlespeech.audio._internal import module_utils from paddlespeech.audio._internal import module_utils
import paddlespeech.audio.ops.paddleaudio.ComputeFbank as ComputeFbank import paddlespeech.audio.ops.paddleaudio.ComputeFbank as ComputeFbank
import paddlespeech.audio.ops.paddleaudio.PitchExtractionOptions as PitchExtractionOptions
import paddlespeech.audio.ops.paddleaudio.FrameExtractionOptions as FrameExtractionOptions
import paddlespeech.audio.ops.paddleaudio.MelBanksOptions as MelBanksOptions
import paddlespeech.audio.ops.paddleaudio.FbankOptions as FbankOptions
import paddlespeech.audio.ops.paddleaudio.ComputeKaldiPitch as ComputeKaldiPitch import paddlespeech.audio.ops.paddleaudio.ComputeKaldiPitch as ComputeKaldiPitch
__all__ = [ __all__ = [
...@@ -20,6 +25,7 @@ __all__ = [ ...@@ -20,6 +25,7 @@ __all__ = [
'pitch', 'pitch',
] ]
@module_utils.requires_kaldi() @module_utils.requires_kaldi()
def fbank(wav, def fbank(wav,
samp_freq: int=16000, samp_freq: int=16000,
...@@ -48,15 +54,38 @@ def fbank(wav, ...@@ -48,15 +54,38 @@ def fbank(wav,
htk_compat: bool=False, htk_compat: bool=False,
use_log_fbank: bool=True, use_log_fbank: bool=True,
use_power: bool=True): use_power: bool=True):
feat = ComputeFbank( frame_opts = FrameExtractionOptions()
samp_freq, frame_shift_ms, frame_length_ms, mel_opts = MelBanksOptions()
dither, preemph_coeff, remove_dc_offset, fbank_opts = FbankOptions()
window_type, round_to_power_of_two, blackman_coeff, frame_opts.samp_freq = samp_freq
snip_edges, allow_downsample, allow_upsample, frame_opts.frame_shift_ms = frame_shift_ms
max_feature_vectors, num_bins, low_freq, frame_opts.frame_length_ms = frame_length_ms
high_freq, vtln_low, vtln_high, debug_mel, frame_opts.dither = dither
htk_mode, use_energy, energy_floor, frame_opts.preemph_coeff = preemph_coeff
raw_energy, htk_compat, use_log_fbank, use_power, wav) frame_opts.remove_dc_offset = remove_dc_offset
frame_opts.window_type = window_type
frame_opts.round_to_power_of_two = round_to_power_of_two
frame_opts.blackman_coeff = blackman_coeff
frame_opts.snip_edges = snip_edges
frame_opts.allow_downsample = allow_downsample
frame_opts.allow_upsample = allow_upsample
frame_opts.max_feature_vectors = max_feature_vectors
mel_opts.num_bins = num_bins
mel_opts.low_freq = low_freq
mel_opts.high_freq = high_freq
mel_opts.vtln_low = vtln_low
mel_opts.vtln_high = vtln_high
mel_opts.debug_mel = debug_mel
mel_opts.htk_mode = htk_mode
fbank_opts.use_energy = use_energy
fbank_opts.energy_floor = energy_floor
fbank_opts.raw_energy = raw_energy
fbank_opts.htk_compat = htk_compat
fbank_opts.use_log_fbank = use_log_fbank
fbank_opts.use_power = use_power
feat = ComputeFbank(frame_opts, mel_opts, fbank_opts, wav)
return feat return feat
@module_utils.requires_kaldi() @module_utils.requires_kaldi()
...@@ -81,23 +110,26 @@ def pitch(wav, ...@@ -81,23 +110,26 @@ def pitch(wav,
recompute_frame: int=500, recompute_frame: int=500,
nccf_ballast_online: bool=False, nccf_ballast_online: bool=False,
snip_edges: bool=True): snip_edges: bool=True):
pitch = ComputeKaldiPitch(samp_freq, frame_shift_ms, pitch_opts = PitchExtractionOptions()
frame_length_ms, pitch_opts.samp_freq = samp_freq
preemph_coeff, pitch_opts.frame_shift_ms = frame_shift_ms
min_f0, pitch_opts.frame_length_ms = frame_length_ms
max_f0, pitch_opts.preemph_coeff = preemph_coeff
soft_min_f0, pitch_opts.min_f0 = min_f0
penalty_factor, pitch_opts.max_f0 = max_f0
lowpass_cutoff, pitch_opts.soft_min_f0 = soft_min_f0
resample_freq, pitch_opts.penalty_factor = penalty_factor
delta_pitch, pitch_opts.lowpass_cutoff = lowpass_cutoff
nccf_ballast, pitch_opts.resample_freq = resample_freq
lowpass_filter_width, pitch_opts.delta_pitch = delta_pitch
upsample_filter_width, pitch_opts.nccf_ballast = nccf_ballast
max_frames_latency, pitch_opts.lowpass_filter_width = lowpass_filter_width
frames_per_chunk, pitch_opts.upsample_filter_width = upsample_filter_width
simulate_first_pass_online, pitch_opts.max_frames_latency = max_frames_latency
recompute_frame, pitch_opts.frames_per_chunk = frames_per_chunk
nccf_ballast_online, pitch_opts.simulate_first_pass_online = simulate_first_pass_online
snip_edges, wav) pitch_opts.recompute_frame = recompute_frame
return pitch pitch_opts.nccf_ballast_online = nccf_ballast_online
\ No newline at end of file pitch_opts.snip_edges = snip_edges
pitch = ComputeKaldiPitch(pitch_opts, wav)
return pitch
...@@ -18,199 +18,58 @@ ...@@ -18,199 +18,58 @@
namespace paddleaudio { namespace paddleaudio {
namespace kaldi { namespace kaldi {
bool InitFbank(float samp_freq, // frame opts bool InitFbank(
float frame_shift_ms, ::kaldi::FrameExtractionOptions frame_opts,
float frame_length_ms, ::kaldi::MelBanksOptions mel_opts,
float dither, FbankOptions fbank_opts) {
float preemph_coeff,
bool remove_dc_offset,
std::string window_type, // e.g. Hamming window
bool round_to_power_of_two,
float blackman_coeff,
bool snip_edges,
bool allow_downsample,
bool allow_upsample,
int max_feature_vectors,
int num_bins, // mel opts
float low_freq,
float high_freq,
float vtln_low,
float vtln_high,
bool debug_mel,
bool htk_mode,
bool use_energy, // fbank opts
float energy_floor,
bool raw_energy,
bool htk_compat,
bool use_log_fbank,
bool use_power) {
::kaldi::FbankOptions opts; ::kaldi::FbankOptions opts;
opts.frame_opts.samp_freq = samp_freq; // frame opts opts.frame_opts = frame_opts;
opts.frame_opts.frame_shift_ms = frame_shift_ms; opts.mel_opts = mel_opts;
opts.frame_opts.frame_length_ms = frame_length_ms; opts.use_energy = fbank_opts.use_energy;
opts.frame_opts.dither = dither; opts.energy_floor = fbank_opts.energy_floor;
opts.frame_opts.preemph_coeff = preemph_coeff; opts.raw_energy = fbank_opts.raw_energy;
opts.frame_opts.remove_dc_offset = remove_dc_offset; opts.htk_compat = fbank_opts.htk_compat;
opts.frame_opts.window_type = window_type; opts.use_log_fbank = fbank_opts.use_log_fbank;
opts.frame_opts.round_to_power_of_two = round_to_power_of_two; opts.use_power = fbank_opts.use_power;
opts.frame_opts.blackman_coeff = blackman_coeff;
opts.frame_opts.snip_edges = snip_edges;
opts.frame_opts.allow_downsample = allow_downsample;
opts.frame_opts.allow_upsample = allow_upsample;
opts.frame_opts.max_feature_vectors = max_feature_vectors;
opts.mel_opts.num_bins = num_bins; // mel opts
opts.mel_opts.low_freq = low_freq;
opts.mel_opts.high_freq = high_freq;
opts.mel_opts.vtln_low = vtln_low;
opts.mel_opts.vtln_high = vtln_high;
opts.mel_opts.debug_mel = debug_mel;
opts.mel_opts.htk_mode = htk_mode;
opts.use_energy = use_energy; // fbank opts
opts.energy_floor = energy_floor;
opts.raw_energy = raw_energy;
opts.htk_compat = htk_compat;
opts.use_log_fbank = use_log_fbank;
opts.use_power = use_power;
paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->InitFbank(opts); paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->InitFbank(opts);
return true; return true;
} }
py::array_t<double> ComputeFbankStreaming(const py::array_t<double>& wav) { py::array_t<float> ComputeFbankStreaming(const py::array_t<float>& wav) {
return paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->ComputeFbank( return paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->ComputeFbank(
wav); wav);
} }
py::array_t<double> ComputeFbank( py::array_t<float> ComputeFbank(
float samp_freq, // frame opts ::kaldi::FrameExtractionOptions frame_opts,
float frame_shift_ms, ::kaldi::MelBanksOptions mel_opts,
float frame_length_ms, FbankOptions fbank_opts,
float dither, const py::array_t<float>& wav) {
float preemph_coeff, InitFbank(frame_opts, mel_opts, fbank_opts);
bool remove_dc_offset, py::array_t<float> result = ComputeFbankStreaming(wav);
std::string window_type, // e.g. Hamming window
bool round_to_power_of_two,
float blackman_coeff,
bool snip_edges,
bool allow_downsample,
bool allow_upsample,
int max_feature_vectors,
int num_bins, // mel opts
float low_freq,
float high_freq,
float vtln_low,
float vtln_high,
bool debug_mel,
bool htk_mode,
bool use_energy, // fbank opts
float energy_floor,
bool raw_energy,
bool htk_compat,
bool use_log_fbank,
bool use_power,
const py::array_t<double>& wav) {
InitFbank(samp_freq, // frame opts
frame_shift_ms,
frame_length_ms,
dither,
preemph_coeff,
remove_dc_offset,
window_type, // e.g. Hamming window
round_to_power_of_two,
blackman_coeff,
snip_edges,
allow_downsample,
allow_upsample,
max_feature_vectors,
num_bins, // mel opts
low_freq,
high_freq,
vtln_low,
vtln_high,
debug_mel,
htk_mode,
use_energy, // fbank opts
energy_floor,
raw_energy,
htk_compat,
use_log_fbank,
use_power);
py::array_t<double> result = ComputeFbankStreaming(wav);
paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->ResetFbank(); paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->ResetFbank();
return result; return result;
} }
void ResetFbank() { void ResetFbank() {
paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->ResetFbank(); paddleaudio::kaldi::KaldiFeatureWrapper::GetInstance()->ResetFbank();
} }
py::array_t<double> ComputeKaldiPitch( py::array_t<float> ComputeKaldiPitch(
int samp_freq, const ::kaldi::PitchExtractionOptions& opts,
float frame_shift_ms, const py::array_t<float>& wav) {
float frame_length_ms, py::buffer_info info = wav.request();
float preemph_coeff, ::kaldi::SubVector<::kaldi::BaseFloat> input_wav((float*)info.ptr, info.size);
int min_f0,
int max_f0,
float soft_min_f0,
float penalty_factor,
int lowpass_cutoff,
int resample_freq,
float delta_pitch,
int nccf_ballast,
int lowpass_filter_width,
int upsample_filter_width,
int max_frames_latency,
int frames_per_chunk,
bool simulate_first_pass_online,
int recompute_frame,
bool nccf_ballast_online,
bool snip_edges,
const py::array_t<double>& wav) {
::kaldi::PitchExtractionOptions opts;
opts.samp_freq = samp_freq;
opts.frame_shift_ms = frame_shift_ms;
opts.frame_length_ms = frame_length_ms;
opts.preemph_coeff = preemph_coeff;
opts.min_f0 = min_f0;
opts.max_f0 = max_f0;
opts.soft_min_f0 = soft_min_f0;
opts.penalty_factor = penalty_factor;
opts.lowpass_cutoff = lowpass_cutoff;
opts.resample_freq = resample_freq;
opts.delta_pitch = delta_pitch;
opts.nccf_ballast = nccf_ballast;
opts.lowpass_filter_width = lowpass_filter_width;
opts.upsample_filter_width = upsample_filter_width;
opts.max_frames_latency = max_frames_latency;
opts.frames_per_chunk = frames_per_chunk;
opts.simulate_first_pass_online = simulate_first_pass_online;
opts.recompute_frame = recompute_frame;
opts.nccf_ballast_online = nccf_ballast_online;
opts.snip_edges = snip_edges;
py::buffer_info info = wav.request();
::kaldi::Vector<::kaldi::BaseFloat> input_wav(info.size);
double* wav_ptr = (double*)info.ptr;
for (int idx = 0; idx < info.size; ++idx) {
input_wav(idx) = *wav_ptr;
wav_ptr++;
}
::kaldi::Matrix<::kaldi::BaseFloat> features; ::kaldi::Matrix<::kaldi::BaseFloat> features;
::kaldi::ComputeKaldiPitch(opts, input_wav, &features); ::kaldi::ComputeKaldiPitch(opts, input_wav, &features);
auto result = py::array_t<double>({features.NumRows(), features.NumCols()}); auto result = py::array_t<float>({features.NumRows(), features.NumCols()});
for (int row_idx = 0; row_idx < features.NumRows(); ++row_idx) { for (int row_idx = 0; row_idx < features.NumRows(); ++row_idx) {
for (int col_idx = 0; col_idx < features.NumCols(); ++col_idx) { std::memcpy(result.mutable_data(row_idx), features.Row(row_idx).Data(),
result.mutable_at(row_idx, col_idx) = features(row_idx, col_idx); sizeof(float)*features.NumCols());
}
}
}
return result; return result;
} }
} // namespace kaldi } // namespace kaldi
} // namespace paddleaudio } // namespace paddleaudio
...@@ -19,96 +19,46 @@ ...@@ -19,96 +19,46 @@
#include <string> #include <string>
#include "paddlespeech/audio/src/pybind/kaldi/kaldi_feature_wrapper.h" #include "paddlespeech/audio/src/pybind/kaldi/kaldi_feature_wrapper.h"
#include "feat/pitch-functions.h"
namespace py = pybind11; namespace py = pybind11;
namespace paddleaudio { namespace paddleaudio {
namespace kaldi { namespace kaldi {
bool InitFbank(float samp_freq, // frame opts struct FbankOptions{
float frame_shift_ms, bool use_energy; // append an extra dimension with energy to the filter banks
float frame_length_ms, float energy_floor;
float dither, bool raw_energy; // If true, compute energy before preemphasis and windowing
float preemph_coeff, bool htk_compat; // If true, put energy last (if using energy)
bool remove_dc_offset, bool use_log_fbank; // if true (default), produce log-filterbank, else linear
std::string window_type, // e.g. Hamming window bool use_power;
bool round_to_power_of_two, FbankOptions(): use_energy(false),
float blackman_coeff, energy_floor(0.0),
bool snip_edges, raw_energy(true),
bool allow_downsample, htk_compat(false),
bool allow_upsample, use_log_fbank(true),
int max_feature_vectors, use_power(true) {}
int num_bins, // mel opts };
float low_freq,
float high_freq,
float vtln_low,
float vtln_high,
bool debug_mel,
bool htk_mode,
bool use_energy, // fbank opts
float energy_floor,
bool raw_energy,
bool htk_compat,
bool use_log_fbank,
bool use_power);
py::array_t<double> ComputeFbank( bool InitFbank(
float samp_freq, // frame opts ::kaldi::FrameExtractionOptions frame_opts,
float frame_shift_ms, ::kaldi::MelBanksOptions mel_opts,
float frame_length_ms, FbankOptions fbank_opts);
float dither,
float preemph_coeff,
bool remove_dc_offset,
std::string window_type, // e.g. Hamming window
bool round_to_power_of_two,
::kaldi::BaseFloat blackman_coeff,
bool snip_edges,
bool allow_downsample,
bool allow_upsample,
int max_feature_vectors,
int num_bins, // mel opts
float low_freq,
float high_freq,
float vtln_low,
float vtln_high,
bool debug_mel,
bool htk_mode,
bool use_energy, // fbank opts
float energy_floor,
bool raw_energy,
bool htk_compat,
bool use_log_fbank,
bool use_power,
const py::array_t<double>& wav);
py::array_t<double> ComputeFbankStreaming(const py::array_t<double>& wav); py::array_t<float> ComputeFbank(
::kaldi::FrameExtractionOptions frame_opts,
::kaldi::MelBanksOptions mel_opts,
FbankOptions fbank_opts,
const py::array_t<float>& wav);
void ResetFbank(); py::array_t<float> ComputeFbankStreaming(const py::array_t<float>& wav);
py::array_t<double> ComputeFbankStreaming(const py::array_t<double>& wav); void ResetFbank();
py::array_t<double> ComputeKaldiPitch( py::array_t<float> ComputeKaldiPitch(
int samp_freq, const ::kaldi::PitchExtractionOptions& opts,
float frame_shift_ms, const py::array_t<float>& wav);
float frame_length_ms,
float preemph_coeff,
int min_f0,
int max_f0,
float soft_min_f0,
float penalty_factor,
int lowpass_cutoff,
int resample_freq,
float delta_pitch,
int nccf_ballast,
int lowpass_filter_width,
int upsample_filter_width,
int max_frames_latency,
int frames_per_chunk,
bool simulate_first_pass_online,
int recompute_frame,
bool nccf_ballast_online,
bool snip_edges,
const py::array_t<double>& wav);
} // namespace kaldi } // namespace kaldi
} // namespace paddleaudio } // namespace paddleaudio
...@@ -27,43 +27,24 @@ bool KaldiFeatureWrapper::InitFbank(::kaldi::FbankOptions opts) { ...@@ -27,43 +27,24 @@ bool KaldiFeatureWrapper::InitFbank(::kaldi::FbankOptions opts) {
return true; return true;
} }
py::array_t<double> KaldiFeatureWrapper::ComputeFbank( py::array_t<float> KaldiFeatureWrapper::ComputeFbank(
const py::array_t<double> wav) { const py::array_t<float> wav) {
py::buffer_info info = wav.request(); py::buffer_info info = wav.request();
::kaldi::Vector<::kaldi::BaseFloat> input_wav(info.size); ::kaldi::SubVector<::kaldi::BaseFloat> input_wav((float*)info.ptr, info.size);
double* wav_ptr = (double*)info.ptr;
for (int idx = 0; idx < info.size; ++idx) {
input_wav(idx) = *wav_ptr;
wav_ptr++;
}
::kaldi::Vector<::kaldi::BaseFloat> feats; ::kaldi::Vector<::kaldi::BaseFloat> feats;
bool flag = fbank_->ComputeFeature(input_wav, &feats); bool flag = fbank_->ComputeFeature(input_wav, &feats);
if (flag == false || feats.Dim() == 0) return py::array_t<double>(); if (flag == false || feats.Dim() == 0) return py::array_t<float>();
auto result = py::array_t<double>(feats.Dim()); auto result = py::array_t<float>(feats.Dim());
py::buffer_info xs = result.request(); py::buffer_info xs = result.request();
std::cout << std::endl; std::cout << std::endl;
double* res_ptr = (double*)xs.ptr; float* res_ptr = (float*)xs.ptr;
for (int idx = 0; idx < feats.Dim(); ++idx) { for (int idx = 0; idx < feats.Dim(); ++idx) {
*res_ptr = feats(idx); *res_ptr = feats(idx);
res_ptr++; res_ptr++;
} }
return result.reshape({feats.Dim() / Dim(), Dim()}); return result.reshape({feats.Dim() / Dim(), Dim()});
/*
py::buffer_info info = wav.request();
std::cout << info.size << std::endl;
auto result = py::array_t<double>(info.size);
//::kaldi::Vector<::kaldi::BaseFloat> input_wav(info.size);
::kaldi::Vector<double> input_wav(info.size);
py::buffer_info info_re = result.request();
memcpy(input_wav.Data(), (double*)info.ptr, wav.nbytes());
memcpy((double*)info_re.ptr, input_wav.Data(), input_wav.Dim()*
sizeof(double));
return result;
*/
} }
} // namesapce kaldi } // namesapce kaldi
......
...@@ -28,7 +28,7 @@ class KaldiFeatureWrapper { ...@@ -28,7 +28,7 @@ class KaldiFeatureWrapper {
public: public:
static KaldiFeatureWrapper* GetInstance(); static KaldiFeatureWrapper* GetInstance();
bool InitFbank(::kaldi::FbankOptions opts); bool InitFbank(::kaldi::FbankOptions opts);
py::array_t<double> ComputeFbank(const py::array_t<double> wav); py::array_t<float> ComputeFbank(const py::array_t<float> wav);
int Dim() { return fbank_->Dim(); } int Dim() { return fbank_->Dim(); }
void ResetFbank() { fbank_->Reset(); } void ResetFbank() { fbank_->Reset(); }
......
...@@ -3,16 +3,76 @@ ...@@ -3,16 +3,76 @@
#include "paddlespeech/audio/src/pybind/kaldi/kaldi_feature.h" #include "paddlespeech/audio/src/pybind/kaldi/kaldi_feature.h"
#include "paddlespeech/audio/src/pybind/sox/io.h" #include "paddlespeech/audio/src/pybind/sox/io.h"
#include "paddlespeech/audio/third_party/kaldi/feat/feature-fbank.h"
PYBIND11_MODULE(_paddleaudio, m) { PYBIND11_MODULE(_paddleaudio, m) {
// Sox #ifdef INCLUDE_SOX
m.def("get_info_file", m.def("get_info_file",
&paddleaudio::sox_io::get_info_file, &paddleaudio::sox_io::get_info_file,
"Get metadata of audio file."); "Get metadata of audio file.");
m.def("get_info_fileobj", m.def("get_info_fileobj",
&paddleaudio::sox_io::get_info_fileobj, &paddleaudio::sox_io::get_info_fileobj,
"Get metadata of audio in file object."); "Get metadata of audio in file object.");
// kaldi feat #endif
#ifdef INCLUDE_KALDI
m.def("ComputeFbank", &paddleaudio::kaldi::ComputeFbank, "compute fbank"); m.def("ComputeFbank", &paddleaudio::kaldi::ComputeFbank, "compute fbank");
py::class_<kaldi::PitchExtractionOptions>(m, "PitchExtractionOptions")
.def(py::init<>())
.def_readwrite("samp_freq", &kaldi::PitchExtractionOptions::samp_freq)
.def_readwrite("frame_shift_ms", &kaldi::PitchExtractionOptions::frame_shift_ms)
.def_readwrite("frame_length_ms", &kaldi::PitchExtractionOptions::frame_length_ms)
.def_readwrite("preemph_coeff", &kaldi::PitchExtractionOptions::preemph_coeff)
.def_readwrite("min_f0", &kaldi::PitchExtractionOptions::min_f0)
.def_readwrite("max_f0", &kaldi::PitchExtractionOptions::max_f0)
.def_readwrite("soft_min_f0", &kaldi::PitchExtractionOptions::soft_min_f0)
.def_readwrite("penalty_factor", &kaldi::PitchExtractionOptions::penalty_factor)
.def_readwrite("lowpass_cutoff", &kaldi::PitchExtractionOptions::lowpass_cutoff)
.def_readwrite("resample_freq", &kaldi::PitchExtractionOptions::resample_freq)
.def_readwrite("delta_pitch", &kaldi::PitchExtractionOptions::delta_pitch)
.def_readwrite("nccf_ballast", &kaldi::PitchExtractionOptions::nccf_ballast)
.def_readwrite("lowpass_filter_width", &kaldi::PitchExtractionOptions::lowpass_filter_width)
.def_readwrite("upsample_filter_width", &kaldi::PitchExtractionOptions::upsample_filter_width)
.def_readwrite("max_frames_latency", &kaldi::PitchExtractionOptions::max_frames_latency)
.def_readwrite("frames_per_chunk", &kaldi::PitchExtractionOptions::frames_per_chunk)
.def_readwrite("simulate_first_pass_online", &kaldi::PitchExtractionOptions::simulate_first_pass_online)
.def_readwrite("recompute_frame", &kaldi::PitchExtractionOptions::recompute_frame)
.def_readwrite("nccf_ballast_online", &kaldi::PitchExtractionOptions::nccf_ballast_online)
.def_readwrite("snip_edges", &kaldi::PitchExtractionOptions::snip_edges);
m.def("ComputeKaldiPitch", &paddleaudio::kaldi::ComputeKaldiPitch, "compute kaldi pitch"); m.def("ComputeKaldiPitch", &paddleaudio::kaldi::ComputeKaldiPitch, "compute kaldi pitch");
py::class_<kaldi::FrameExtractionOptions>(m, "FrameExtractionOptions")
.def(py::init<>())
.def_readwrite("samp_freq", &kaldi::FrameExtractionOptions::samp_freq)
.def_readwrite("frame_shift_ms", &kaldi::FrameExtractionOptions::frame_shift_ms)
.def_readwrite("frame_length_ms", &kaldi::FrameExtractionOptions::frame_length_ms)
.def_readwrite("dither", &kaldi::FrameExtractionOptions::dither)
.def_readwrite("preemph_coeff", &kaldi::FrameExtractionOptions::preemph_coeff)
.def_readwrite("remove_dc_offset", &kaldi::FrameExtractionOptions::remove_dc_offset)
.def_readwrite("window_type", &kaldi::FrameExtractionOptions::window_type)
.def_readwrite("round_to_power_of_two", &kaldi::FrameExtractionOptions::round_to_power_of_two)
.def_readwrite("blackman_coeff", &kaldi::FrameExtractionOptions::blackman_coeff)
.def_readwrite("snip_edges", &kaldi::FrameExtractionOptions::snip_edges)
.def_readwrite("allow_downsample", &kaldi::FrameExtractionOptions::allow_downsample)
.def_readwrite("allow_upsample", &kaldi::FrameExtractionOptions::allow_upsample)
.def_readwrite("max_feature_vectors", &kaldi::FrameExtractionOptions::max_feature_vectors);
py::class_<kaldi::MelBanksOptions>(m, "MelBanksOptions")
.def(py::init<>())
.def_readwrite("num_bins", &kaldi::MelBanksOptions::num_bins)
.def_readwrite("low_freq", &kaldi::MelBanksOptions::low_freq)
.def_readwrite("high_freq", &kaldi::MelBanksOptions::high_freq)
.def_readwrite("vtln_low", &kaldi::MelBanksOptions::vtln_low)
.def_readwrite("vtln_high", &kaldi::MelBanksOptions::vtln_high)
.def_readwrite("debug_mel", &kaldi::MelBanksOptions::debug_mel)
.def_readwrite("htk_mode", &kaldi::MelBanksOptions::htk_mode);
py::class_<paddleaudio::kaldi::FbankOptions>(m, "FbankOptions")
.def(py::init<>())
.def_readwrite("use_energy", &paddleaudio::kaldi::FbankOptions::use_energy)
.def_readwrite("energy_floor", &paddleaudio::kaldi::FbankOptions::energy_floor)
.def_readwrite("raw_energy", &paddleaudio::kaldi::FbankOptions::raw_energy)
.def_readwrite("htk_compat", &paddleaudio::kaldi::FbankOptions::htk_compat)
.def_readwrite("use_log_fbank", &paddleaudio::kaldi::FbankOptions::use_log_fbank)
.def_readwrite("use_power", &paddleaudio::kaldi::FbankOptions::use_power);
#endif
} }
...@@ -32,9 +32,9 @@ target_include_directories(kaldi-base PUBLIC ${CMAKE_CURRENT_SOURCE_DIR}) ...@@ -32,9 +32,9 @@ target_include_directories(kaldi-base PUBLIC ${CMAKE_CURRENT_SOURCE_DIR})
# kaldi-matrix # kaldi-matrix
add_library(kaldi-matrix STATIC add_library(kaldi-matrix STATIC
matrix/compressed-matrix.cc matrix/compressed-matrix.cc
matrix/matrix-functions.cc
matrix/kaldi-matrix.cc matrix/kaldi-matrix.cc
matrix/kaldi-vector.cc matrix/kaldi-vector.cc
matrix/matrix-functions.cc
matrix/optimization.cc matrix/optimization.cc
matrix/packed-matrix.cc matrix/packed-matrix.cc
matrix/qr.cc matrix/qr.cc
...@@ -65,14 +65,14 @@ target_link_libraries(kaldi-util PUBLIC kaldi-base kaldi-matrix) ...@@ -65,14 +65,14 @@ target_link_libraries(kaldi-util PUBLIC kaldi-base kaldi-matrix)
# kaldi-feat-common # kaldi-feat-common
add_library(kaldi-feat-common STATIC add_library(kaldi-feat-common STATIC
feat/wave-reader.cc feat/cmvn.cc
feat/signal.cc
feat/feature-functions.cc feat/feature-functions.cc
feat/feature-window.cc feat/feature-window.cc
feat/resample.cc
feat/pitch-functions.cc
feat/mel-computations.cc feat/mel-computations.cc
feat/cmvn.cc feat/pitch-functions.cc
feat/resample.cc
feat/signal.cc
feat/wave-reader.cc
) )
target_include_directories(kaldi-feat-common PUBLIC ${CMAKE_CURRENT_SOURCE_DIR}) target_include_directories(kaldi-feat-common PUBLIC ${CMAKE_CURRENT_SOURCE_DIR})
target_link_libraries(kaldi-feat-common PUBLIC kaldi-base kaldi-matrix kaldi-util) target_link_libraries(kaldi-feat-common PUBLIC kaldi-base kaldi-matrix kaldi-util)
......
// itf/online-feature-itf.h // feat/online-feature-itf.h
// Copyright 2013 Johns Hopkins University (author: Daniel Povey) // Copyright 2013 Johns Hopkins University (author: Daniel Povey)
...@@ -17,8 +17,8 @@ ...@@ -17,8 +17,8 @@
// See the Apache 2 License for the specific language governing permissions and // See the Apache 2 License for the specific language governing permissions and
// limitations under the License. // limitations under the License.
#ifndef KALDI_ITF_ONLINE_FEATURE_ITF_H_ #ifndef KALDI_FEAT_ONLINE_FEATURE_ITF_H_
#define KALDI_ITF_ONLINE_FEATURE_ITF_H_ 1 #define KALDI_FEAT_ONLINE_FEATURE_ITF_H_ 1
#include "base/kaldi-common.h" #include "base/kaldi-common.h"
#include "matrix/matrix-lib.h" #include "matrix/matrix-lib.h"
......
...@@ -16,31 +16,43 @@ import unittest ...@@ -16,31 +16,43 @@ import unittest
import numpy as np import numpy as np
import paddle import paddle
import paddlespeech.audio.kaldi.kaldi.fbank as fbank import paddlespeech.audio.kaldi.fbank as fbank
import paddlespeech.audio.kaldi.kaldi.pitch as pitch import paddlespeech.audio.kaldi.pitch as pitch
import kaldiio import ReadHelper from kaldiio import ReadHelper
# the groundtruth feats computed in kaldi command below.
#compute-fbank-feats --dither=0 scp:$wav_scp ark,t:fbank_feat.ark
#compute-kaldi-pitch-feats --sample-frequency=16000 scp:$wav_scp ark,t:pitch_feat.ark
class TestKaldiFbank(unittest.TestCase): class TestKaldiFbank(unittest.TestCase):
def test_fbank_pitch(self): def test_fbank(self):
fbank_groundtruth = None fbank_groundtruth = {}
pitch_groundtruth = None with ReadHelper('ark:testdata/fbank_feat.ark') as reader:
with ReadHelper('ark:fbank_feat.ark') as reader:
for key, feat in reader: for key, feat in reader:
fbank_groundtruth = feat fbank_groundtruth[key] = feat
with ReadHelper('ark:testdata/wav.ark') as reader:
for key, wav in reader:
fbank_feat = fbank(wav)
fbank_check = fbank_groundtruth[key]
np.testing.assert_array_almost_equal(
fbank_feat, fbank_check, decimal=4)
with ReadHelper('ark:pitch_feat.ark') as reader: def test_pitch(self):
pitch_groundtruth = {}
with ReadHelper('ark:testdata/pitch_feat.ark') as reader:
for key, feat in reader: for key, feat in reader:
pitch_groundtruth = feat pitch_groundtruth[key] = feat
with ReadHelper('ark:wav.ark') as reader: with ReadHelper('ark:testdata/wav.ark') as reader:
for key, wav in reader: for key, wav in reader:
fbank_feat = fbank(wav)
pitch_feat = pitch(wav) pitch_feat = pitch(wav)
pitch_check = pitch_groundtruth[key]
np.testing.assert_array_almost_equal( np.testing.assert_array_almost_equal(
fbank_feat, fbank_groundtruth, decimal=4) pitch_feat, pitch_check, decimal=4)
np.testing.assert_array_almost_equal(
pitch_feat, pitch_groundtruth, decimal=4)
if __name__ == '__main__': if __name__ == '__main__':
unittest.main() unittest.main()
BAC009S0768W0290 [ test_wav [
8.86961 7.025289 6.664165 7.169617 7.317829 7.188704 8.351522 8.843228 7.711394 7.231504 6.903938 7.053499 7.293597 8.331067 7.871729 9.206844 9.434045 9.768963 10.01864 10.25888 10.68228 10.55968 10.62156 8.86961 7.025289 6.664165 7.169617 7.317829 7.188704 8.351522 8.843228 7.711394 7.231504 6.903938 7.053499 7.293597 8.331067 7.871729 9.206844 9.434045 9.768963 10.01864 10.25888 10.68228 10.55968 10.62156
8.364346 7.526375 6.915925 6.705005 7.641569 7.827819 8.253532 7.794802 7.522578 7.222802 7.388284 7.493527 8.257078 9.141049 8.994849 9.348937 9.015431 9.343955 10.42236 10.13459 10.40709 10.39534 10.22199 8.364346 7.526375 6.915925 6.705005 7.641569 7.827819 8.253532 7.794802 7.522578 7.222802 7.388284 7.493527 8.257078 9.141049 8.994849 9.348937 9.015431 9.343955 10.42236 10.13459 10.40709 10.39534 10.22199
7.230361 6.771988 6.422344 7.535786 7.164408 6.342811 8.723886 8.481328 6.804535 7.276428 7.471786 7.581892 8.757826 8.764767 8.570841 8.741215 9.756334 9.515329 9.720121 10.26671 10.67728 10.5581 10.61378 7.230361 6.771988 6.422344 7.535786 7.164408 6.342811 8.723886 8.481328 6.804535 7.276428 7.471786 7.581892 8.757826 8.764767 8.570841 8.741215 9.756334 9.515329 9.720121 10.26671 10.67728 10.5581 10.61378
...@@ -33,7 +33,7 @@ BAC009S0768W0290 [ ...@@ -33,7 +33,7 @@ BAC009S0768W0290 [
9.17825 6.552885 7.865911 7.314655 7.429624 7.467305 7.331274 8.097523 8.513691 7.603092 8.123087 8.988563 8.24368 7.665757 8.043156 9.323641 9.559673 10.4114 10.44213 10.46176 10.31303 10.41219 10.04096 9.17825 6.552885 7.865911 7.314655 7.429624 7.467305 7.331274 8.097523 8.513691 7.603092 8.123087 8.988563 8.24368 7.665757 8.043156 9.323641 9.559673 10.4114 10.44213 10.46176 10.31303 10.41219 10.04096
9.499084 6.913695 8.680465 8.913202 7.983476 7.54614 8.20214 8.433187 7.619872 7.079637 7.59503 7.827682 8.021211 8.954014 8.512682 8.685501 9.039448 9.882102 10.09629 9.995301 10.25326 10.52707 10.41024 9.499084 6.913695 8.680465 8.913202 7.983476 7.54614 8.20214 8.433187 7.619872 7.079637 7.59503 7.827682 8.021211 8.954014 8.512682 8.685501 9.039448 9.882102 10.09629 9.995301 10.25326 10.52707 10.41024
8.841949 7.852749 8.220187 8.067208 6.958006 6.525739 7.606658 8.743006 8.618779 7.857424 7.85938 6.839745 8.494206 7.93556 8.554915 9.17892 9.411014 9.403722 9.75618 9.915223 10.4127 10.62058 10.75261 8.841949 7.852749 8.220187 8.067208 6.958006 6.525739 7.606658 8.743006 8.618779 7.857424 7.85938 6.839745 8.494206 7.93556 8.554915 9.17892 9.411014 9.403722 9.75618 9.915223 10.4127 10.62058 10.75261
8.80931 7.176473 8.226482 8.048065 6.875594 7.035853 8.159007 8.788584 7.998541 7.745961 7.02769 7.343524 8.768233 8.742394 8.993815 8.919962 8.948602 9.299537 9.644718 9.328181 10.0551 10.60812 10.26714 8.80931 7.176473 8.226482 8.048065 6.875594 7.035853 8.159007 8.788584 7.998541 7.745961 7.02769 7.343524 8.768233 8.742394 8.993815 8.919962 8.948602 9.299537 9.644719 9.328181 10.0551 10.60812 10.26714
8.416738 7.433433 8.202932 7.654713 7.487177 7.454067 7.807778 8.21654 7.973643 7.745943 7.477229 7.699207 8.724244 8.921854 9.167027 9.329788 9.198338 9.449234 9.350556 9.504007 10.01113 10.77754 10.79311 8.416738 7.433433 8.202932 7.654713 7.487177 7.454067 7.807778 8.21654 7.973643 7.745943 7.477229 7.699207 8.724244 8.921854 9.167027 9.329788 9.198338 9.449234 9.350556 9.504007 10.01113 10.77754 10.79311
7.265522 8.85788 8.794858 6.660202 5.630237 7.668158 8.690257 8.2572 7.200497 7.342714 7.748627 8.173976 8.632828 8.53996 9.053345 9.001765 9.227647 10.09744 9.63631 10.25264 9.908823 11.11253 11.10346 7.265522 8.85788 8.794858 6.660202 5.630237 7.668158 8.690257 8.2572 7.200497 7.342714 7.748627 8.173976 8.632828 8.53996 9.053345 9.001765 9.227647 10.09744 9.63631 10.25264 9.908823 11.11253 11.10346
8.641815 8.838676 8.314915 6.847168 5.620167 7.186635 8.486069 8.301935 7.863872 7.790708 7.733249 8.113005 8.49118 7.827488 8.389672 8.932463 9.147495 10.10519 10.22344 10.33928 10.09212 10.47646 10.13575 8.641815 8.838676 8.314915 6.847168 5.620167 7.186635 8.486069 8.301935 7.863872 7.790708 7.733249 8.113005 8.49118 7.827488 8.389672 8.932463 9.147495 10.10519 10.22344 10.33928 10.09212 10.47646 10.13575
...@@ -51,7 +51,7 @@ BAC009S0768W0290 [ ...@@ -51,7 +51,7 @@ BAC009S0768W0290 [
8.511848 7.523149 8.195268 7.966453 7.744322 8.485562 8.004887 7.922952 8.245237 7.383193 7.844249 8.127041 8.127259 8.443523 8.102531 8.774108 8.681726 9.477551 8.882012 9.804171 10.55685 10.48077 10.37192 8.511848 7.523149 8.195268 7.966453 7.744322 8.485562 8.004887 7.922952 8.245237 7.383193 7.844249 8.127041 8.127259 8.443523 8.102531 8.774108 8.681726 9.477551 8.882012 9.804171 10.55685 10.48077 10.37192
7.975676 7.082146 7.933741 6.951503 6.272567 7.088233 7.917744 7.379583 8.238628 7.820266 8.475443 8.424726 8.05715 8.067741 8.94787 8.867351 9.374059 9.266661 9.49703 10.01138 10.3168 10.71612 10.27346 7.975676 7.082146 7.933741 6.951503 6.272567 7.088233 7.917744 7.379583 8.238628 7.820266 8.475443 8.424726 8.05715 8.067741 8.94787 8.867351 9.374059 9.266661 9.49703 10.01138 10.3168 10.71612 10.27346
8.813721 8.656951 7.681757 7.203363 7.488046 8.216457 8.221495 7.714307 7.938663 7.708951 8.019526 7.926672 7.864351 7.698409 8.801851 8.555806 9.788485 9.553381 9.62245 10.2158 9.915847 10.40117 10.80687 8.813721 8.656951 7.681757 7.203363 7.488046 8.216457 8.221495 7.714307 7.938663 7.708951 8.019526 7.926672 7.864351 7.698409 8.801851 8.555806 9.788485 9.553381 9.62245 10.2158 9.915847 10.40117 10.80687
6.477304 7.734454 8.373713 6.965827 8.077723 8.442548 7.893295 8.407219 7.909376 8.080144 8.55372 7.803288 6.868239 8.449481 8.860373 8.910608 9.437862 9.165442 9.822459 10.30201 10.48472 10.77984 11.18594 6.477304 7.734454 8.373713 6.965827 8.077723 8.442548 7.893295 8.407219 7.909376 8.080144 8.55372 7.803288 6.868239 8.449481 8.860373 8.910608 9.437862 9.165442 9.82246 10.30201 10.48472 10.77984 11.18594
9.42877 10.45913 10.29159 9.716755 9.220295 8.658374 6.794528 6.873018 7.217855 8.288869 8.809176 8.809996 8.093638 8.87556 9.207784 9.647738 9.825712 10.08347 9.918015 10.10553 10.54475 11.02415 10.92163 9.42877 10.45913 10.29159 9.716755 9.220295 8.658374 6.794528 6.873018 7.217855 8.288869 8.809176 8.809996 8.093638 8.87556 9.207784 9.647738 9.825712 10.08347 9.918015 10.10553 10.54475 11.02415 10.92163
13.23045 15.72255 15.14105 16.25381 15.65043 12.23466 10.81911 10.62931 10.80597 11.77175 12.40585 12.68368 13.26326 11.76209 10.96095 14.30546 15.08591 12.37251 12.23275 11.97119 10.67747 10.71765 10.87486 13.23045 15.72255 15.14105 16.25381 15.65043 12.23466 10.81911 10.62931 10.80597 11.77175 12.40585 12.68368 13.26326 11.76209 10.96095 14.30546 15.08591 12.37251 12.23275 11.97119 10.67747 10.71765 10.87486
13.65519 16.94076 16.0239 18.20588 16.9831 13.7648 12.16126 11.07043 11.80799 12.73412 12.98298 12.90398 14.25156 11.9087 10.24638 14.79149 15.7653 13.01829 12.92099 13.79269 11.3934 11.02932 11.13173 13.65519 16.94076 16.0239 18.20588 16.9831 13.7648 12.16126 11.07043 11.80799 12.73412 12.98298 12.90398 14.25156 11.9087 10.24638 14.79149 15.7653 13.01829 12.92099 13.79269 11.3934 11.02932 11.13173
...@@ -153,7 +153,7 @@ BAC009S0768W0290 [ ...@@ -153,7 +153,7 @@ BAC009S0768W0290 [
10.35312 17.61216 18.04445 15.89868 17.93677 15.43736 14.92465 10.95503 10.74119 11.10365 10.10367 8.769894 9.549344 9.448477 10.16095 9.991289 10.12919 10.67581 10.30081 10.2757 10.61878 11.08467 11.66054 10.35312 17.61216 18.04445 15.89868 17.93677 15.43736 14.92465 10.95503 10.74119 11.10365 10.10367 8.769894 9.549344 9.448477 10.16095 9.991289 10.12919 10.67581 10.30081 10.2757 10.61878 11.08467 11.66054
10.57029 16.80257 17.43232 15.33712 17.40169 14.69754 13.7979 10.32226 10.54766 10.62139 9.538151 8.558439 8.763721 9.43328 9.823753 9.941569 10.20876 10.29988 9.839418 10.4947 10.67628 10.63656 11.36743 10.57029 16.80257 17.43232 15.33712 17.40169 14.69754 13.7979 10.32226 10.54766 10.62139 9.538151 8.558439 8.763721 9.43328 9.823753 9.941569 10.20876 10.29988 9.839418 10.4947 10.67628 10.63656 11.36743
10.88069 16.40481 16.94452 14.63999 16.55998 13.75831 12.04815 10.07983 9.779847 9.41483 9.367539 8.638872 7.551649 8.591156 9.22356 9.253392 9.312204 10.12255 9.771526 10.66726 10.28885 10.70903 10.99041 10.88069 16.40481 16.94452 14.63999 16.55998 13.75831 12.04815 10.07983 9.779847 9.41483 9.367539 8.638872 7.551649 8.591156 9.22356 9.253392 9.312204 10.12255 9.771526 10.66726 10.28885 10.70903 10.99041
10.68995 15.9614 16.66981 12.87561 15.32809 13.38852 13.34967 10.08965 9.267484 8.510974 8.937634 8.066225 7.492024 8.559677 9.379137 8.934621 9.395594 9.947574 9.762502 10.16802 10.52471 10.62313 10.52163 10.68995 15.9614 16.66981 12.87561 15.32809 13.38852 13.34967 10.08965 9.267484 8.510974 8.937634 8.066225 7.492024 8.559677 9.379137 8.934621 9.395594 9.947574 9.762503 10.16802 10.52471 10.62313 10.52163
10.10682 15.73363 16.55744 12.98704 15.02876 13.22308 13.64594 9.306398 8.513678 8.840482 8.639846 8.813548 8.690471 9.372956 9.21609 9.271674 10.22423 10.17199 9.91317 10.44354 10.81481 10.71306 10.58567 10.10682 15.73363 16.55744 12.98704 15.02876 13.22308 13.64594 9.306398 8.513678 8.840482 8.639846 8.813548 8.690471 9.372956 9.21609 9.271674 10.22423 10.17199 9.91317 10.44354 10.81481 10.71306 10.58567
10.53498 15.85452 16.48894 13.69206 15.73015 14.98417 13.35866 12.12415 12.66079 12.8636 12.57128 11.65822 10.42173 9.932479 10.30401 10.88577 10.69672 11.60742 10.67614 10.5448 11.20179 12.58635 13.41792 10.53498 15.85452 16.48894 13.69206 15.73015 14.98417 13.35866 12.12415 12.66079 12.8636 12.57128 11.65822 10.42173 9.932479 10.30401 10.88577 10.69672 11.60742 10.67614 10.5448 11.20179 12.58635 13.41792
10.96499 15.49205 16.39072 14.58421 16.09194 14.12068 12.85947 10.9668 11.6846 11.61401 11.32033 10.1519 9.595464 9.126978 9.282423 9.871722 10.47498 11.93141 10.77083 10.79808 10.82797 12.26179 13.4949 10.96499 15.49205 16.39072 14.58421 16.09194 14.12068 12.85947 10.9668 11.6846 11.61401 11.32033 10.1519 9.595464 9.126978 9.282423 9.871722 10.47498 11.93141 10.77083 10.79808 10.82797 12.26179 13.4949
...@@ -264,7 +264,7 @@ BAC009S0768W0290 [ ...@@ -264,7 +264,7 @@ BAC009S0768W0290 [
12.84129 12.74346 11.62644 11.11886 11.60124 9.904121 10.04816 10.7376 10.31966 11.05361 11.45463 12.15746 11.15053 10.69711 11.84554 13.98456 14.60289 15.31413 15.49967 16.84238 18.05069 19.01266 18.84834 12.84129 12.74346 11.62644 11.11886 11.60124 9.904121 10.04816 10.7376 10.31966 11.05361 11.45463 12.15746 11.15053 10.69711 11.84554 13.98456 14.60289 15.31413 15.49967 16.84238 18.05069 19.01266 18.84834
12.53398 11.96433 9.244778 8.572387 10.26614 9.39289 10.5042 10.72253 10.65647 12.75043 13.54582 13.20332 12.30947 11.8775 13.39289 15.73803 16.03198 17.65893 17.08116 18.5041 19.5771 20.24899 20.35165 12.53398 11.96433 9.244778 8.572387 10.26614 9.39289 10.5042 10.72253 10.65647 12.75043 13.54582 13.20332 12.30947 11.8775 13.39289 15.73803 16.03198 17.65893 17.08116 18.5041 19.5771 20.24899 20.35165
12.00563 12.20351 10.276 9.838881 10.18145 9.774684 9.775256 10.85217 11.57201 12.9943 13.72266 13.57533 12.36394 12.41757 14.64912 16.40559 16.40833 17.94178 17.0117 19.56192 20.42689 21.10626 20.54123 12.00563 12.20351 10.276 9.838881 10.18145 9.774684 9.775256 10.85217 11.57201 12.9943 13.72266 13.57533 12.36394 12.41757 14.64912 16.40559 16.40833 17.94178 17.0117 19.56192 20.42689 21.10626 20.54123
11.91491 12.22656 10.11695 11.68905 13.45684 12.16579 11.17595 11.02882 13.19395 13.89767 15.23678 15.18915 13.55568 14.68092 15.77575 16.75733 17.13061 17.34155 17.21396 19.74595 20.57611 22.05666 21.36359 11.91491 12.22656 10.11695 11.68905 13.45684 12.16579 11.17595 11.02882 13.19395 13.89767 15.23678 15.18915 13.55568 14.68092 15.77575 16.75733 17.13061 17.34155 17.21397 19.74595 20.57611 22.05666 21.36359
11.47355 11.28028 10.45217 11.66897 13.02617 12.40421 12.3838 12.38136 13.96514 15.68431 16.50488 16.14618 15.39929 15.91039 16.42896 17.51905 18.45585 18.59583 17.75705 19.62965 20.81224 22.27122 21.80147 11.47355 11.28028 10.45217 11.66897 13.02617 12.40421 12.3838 12.38136 13.96514 15.68431 16.50488 16.14618 15.39929 15.91039 16.42896 17.51905 18.45585 18.59583 17.75705 19.62965 20.81224 22.27122 21.80147
12.52662 11.94858 10.55505 12.42413 13.77102 13.32065 12.9342 13.66854 14.39565 16.63391 17.94618 17.4248 17.46566 16.57822 16.48766 17.86062 18.27674 18.54208 17.23242 19.31924 20.2264 21.92178 21.3364 12.52662 11.94858 10.55505 12.42413 13.77102 13.32065 12.9342 13.66854 14.39565 16.63391 17.94618 17.4248 17.46566 16.57822 16.48766 17.86062 18.27674 18.54208 17.23242 19.31924 20.2264 21.92178 21.3364
12.02873 11.26655 9.571183 11.58556 13.19479 12.65055 12.59585 14.40476 14.95008 16.4713 18.34317 18.11756 17.86362 16.10263 16.13897 16.93494 18.05787 17.58092 17.09885 18.80086 19.4799 20.65734 19.97151 12.02873 11.26655 9.571183 11.58556 13.19479 12.65055 12.59585 14.40476 14.95008 16.4713 18.34317 18.11756 17.86362 16.10263 16.13897 16.93494 18.05787 17.58092 17.09885 18.80086 19.4799 20.65734 19.97151
...@@ -296,7 +296,7 @@ BAC009S0768W0290 [ ...@@ -296,7 +296,7 @@ BAC009S0768W0290 [
16.31133 18.53433 16.33694 15.77417 14.38188 12.95522 13.08407 14.4475 12.69577 13.27632 12.01401 11.38529 10.35604 10.744 10.78147 10.85441 10.54302 12.20752 11.1479 11.46902 11.70803 13.0295 13.62829 16.31133 18.53433 16.33694 15.77417 14.38188 12.95522 13.08407 14.4475 12.69577 13.27632 12.01401 11.38529 10.35604 10.744 10.78147 10.85441 10.54302 12.20752 11.1479 11.46902 11.70803 13.0295 13.62829
16.08484 18.22621 16.04434 15.1363 12.58238 11.89639 12.57116 13.53181 14.12426 14.20648 11.83826 11.15889 9.9625 10.32529 9.984441 10.63607 11.00616 12.5833 11.28041 11.6917 11.89614 12.90713 13.29698 16.08484 18.22621 16.04434 15.1363 12.58238 11.89639 12.57116 13.53181 14.12426 14.20648 11.83826 11.15889 9.9625 10.32529 9.984441 10.63607 11.00616 12.5833 11.28041 11.6917 11.89614 12.90713 13.29698
15.68179 17.81505 16.00374 14.72812 14.84708 11.26076 12.04008 13.00523 14.13205 13.28368 11.21361 10.097 9.955743 10.26499 9.792438 9.863858 11.07145 12.3472 10.51815 10.99274 11.61275 13.19388 13.72785 15.68179 17.81505 16.00374 14.72812 14.84708 11.26076 12.04008 13.00523 14.13205 13.28368 11.21361 10.097 9.955743 10.26499 9.792438 9.863858 11.07145 12.3472 10.51815 10.99274 11.61275 13.19388 13.72785
14.55198 16.86638 15.5845 14.5592 14.73209 12.26241 10.81983 11.97698 13.21972 12.68782 10.91807 10.4126 9.59472 10.19615 9.584566 9.555467 10.64191 12.16234 10.07995 11.50145 12.38193 12.66189 12.71277 14.55198 16.86638 15.5845 14.5592 14.73209 12.26241 10.81983 11.97698 13.21972 12.68782 10.91807 10.4126 9.59472 10.19615 9.584566 9.555467 10.64191 12.16234 10.07995 11.50145 12.38194 12.66189 12.71277
13.01004 15.59743 15.64693 14.08796 13.8486 11.90227 10.5667 10.79841 12.75414 11.89225 9.598926 9.206168 9.479238 8.989665 8.048623 9.163903 10.12297 11.2002 10.10107 10.59673 10.9262 11.29577 11.6629 13.01004 15.59743 15.64693 14.08796 13.8486 11.90227 10.5667 10.79841 12.75414 11.89225 9.598926 9.206168 9.479238 8.989665 8.048623 9.163903 10.12297 11.2002 10.10107 10.59673 10.9262 11.29577 11.6629
13.91573 16.00849 15.0316 13.62253 12.95412 9.966305 10.1017 9.991467 9.596074 9.605503 9.343888 9.190509 8.865524 8.973734 8.919617 9.209815 10.08192 10.85753 10.00404 9.867455 10.36516 11.38496 11.67881 13.91573 16.00849 15.0316 13.62253 12.95412 9.966305 10.1017 9.991467 9.596074 9.605503 9.343888 9.190509 8.865524 8.973734 8.919617 9.209815 10.08192 10.85753 10.00404 9.867455 10.36516 11.38496 11.67881
14.8278 16.76171 14.70668 13.6729 13.04084 9.941384 9.693533 10.51062 10.44051 10.19218 9.282916 9.032 8.986729 8.863693 9.409104 9.42415 9.590022 10.41179 9.549519 9.795614 10.16903 11.44894 11.5452 14.8278 16.76171 14.70668 13.6729 13.04084 9.941384 9.693533 10.51062 10.44051 10.19218 9.282916 9.032 8.986729 8.863693 9.409104 9.42415 9.590022 10.41179 9.549519 9.795614 10.16903 11.44894 11.5452
...@@ -442,7 +442,7 @@ BAC009S0768W0290 [ ...@@ -442,7 +442,7 @@ BAC009S0768W0290 [
10.1434 9.600281 9.03609 9.28277 9.389798 9.782507 9.522714 9.155346 10.51925 11.83723 12.88527 13.05917 12.5973 11.04044 12.4058 11.76693 11.41435 11.29793 11.33523 11.57119 11.21824 12.67894 11.60467 10.1434 9.600281 9.03609 9.28277 9.389798 9.782507 9.522714 9.155346 10.51925 11.83723 12.88527 13.05917 12.5973 11.04044 12.4058 11.76693 11.41435 11.29793 11.33523 11.57119 11.21824 12.67894 11.60467
9.044415 9.35461 8.125829 8.155436 10.21073 9.420408 8.485256 9.519516 10.80159 11.03508 12.98993 12.86469 12.11976 11.60614 11.22908 11.30737 11.26812 11.07872 11.49184 12.23885 12.01657 12.81706 11.95831 9.044415 9.35461 8.125829 8.155436 10.21073 9.420408 8.485256 9.519516 10.80159 11.03508 12.98993 12.86469 12.11976 11.60614 11.22908 11.30737 11.26812 11.07872 11.49184 12.23885 12.01657 12.81706 11.95831
9.557627 10.25238 8.452591 8.784152 10.9992 9.823544 9.510536 10.38744 11.27521 11.65287 13.02484 12.76013 11.33446 11.90731 11.69084 11.35221 11.25088 11.1325 11.48025 11.96735 11.96839 12.37707 11.87469 9.557627 10.25238 8.452591 8.784152 10.9992 9.823544 9.510536 10.38744 11.27521 11.65287 13.02484 12.76013 11.33446 11.90731 11.69084 11.35221 11.25088 11.1325 11.48025 11.96735 11.96839 12.37707 11.87469
10.23095 9.161502 8.99103 8.923839 9.805343 9.837078 10.10092 9.621623 10.84666 11.88772 13.02984 13.09626 11.90776 11.65839 11.98773 11.63274 11.56222 10.86827 11.27272 11.77922 11.91178 12.68476 12.05235 10.23095 9.161502 8.99103 8.923839 9.805343 9.837078 10.10092 9.621623 10.84666 11.88772 13.02984 13.09626 11.90776 11.65839 11.98773 11.63274 11.56222 10.86827 11.27272 11.77922 11.91178 12.68476 12.05236
8.874165 7.809851 8.695865 8.223797 8.763299 9.566321 8.770155 9.008782 11.19149 11.83618 13.52786 13.19089 11.91928 11.96163 12.16576 11.49836 11.79749 10.94192 10.88142 11.00608 11.66361 12.51995 11.84705 8.874165 7.809851 8.695865 8.223797 8.763299 9.566321 8.770155 9.008782 11.19149 11.83618 13.52786 13.19089 11.91928 11.96163 12.16576 11.49836 11.79749 10.94192 10.88142 11.00608 11.66361 12.51995 11.84705
8.437733 8.480018 7.988172 8.590461 9.420288 9.875575 9.504238 9.388609 10.90206 11.65753 13.35867 13.6816 12.48646 11.95356 12.16133 11.43572 11.42155 11.1403 10.60003 11.26259 11.62654 12.52154 11.82845 8.437733 8.480018 7.988172 8.590461 9.420288 9.875575 9.504238 9.388609 10.90206 11.65753 13.35867 13.6816 12.48646 11.95356 12.16133 11.43572 11.42155 11.1403 10.60003 11.26259 11.62654 12.52154 11.82845
9.964341 8.923758 9.201259 9.687395 9.499485 9.23505 8.127786 8.023572 10.40248 11.75716 12.92915 12.92148 11.44932 11.59385 12.10262 10.90831 11.27934 11.05236 10.57544 10.54616 11.69068 12.66987 12.08684 9.964341 8.923758 9.201259 9.687395 9.499485 9.23505 8.127786 8.023572 10.40248 11.75716 12.92915 12.92148 11.44932 11.59385 12.10262 10.90831 11.27934 11.05236 10.57544 10.54616 11.69068 12.66987 12.08684
...@@ -564,7 +564,7 @@ BAC009S0768W0290 [ ...@@ -564,7 +564,7 @@ BAC009S0768W0290 [
9.56905 11.07326 11.29717 12.00945 12.56924 11.74636 11.67797 12.27109 12.33903 15.01359 17.29026 17.98109 16.23312 14.9431 14.57544 15.20214 16.10517 16.19224 15.99478 15.25868 15.40402 16.06674 15.44316 9.56905 11.07326 11.29717 12.00945 12.56924 11.74636 11.67797 12.27109 12.33903 15.01359 17.29026 17.98109 16.23312 14.9431 14.57544 15.20214 16.10517 16.19224 15.99478 15.25868 15.40402 16.06674 15.44316
10.508 10.89142 10.47173 10.95241 11.76593 10.98585 10.76927 12.52917 13.36483 14.31004 15.60877 16.93384 15.8426 14.30149 13.70551 14.91785 15.92855 15.53096 15.40199 15.04334 15.08857 15.01525 14.25574 10.508 10.89142 10.47173 10.95241 11.76593 10.98585 10.76927 12.52917 13.36483 14.31004 15.60877 16.93384 15.8426 14.30149 13.70551 14.91785 15.92855 15.53096 15.40199 15.04334 15.08857 15.01525 14.25574
10.63981 10.66823 10.20522 11.10935 11.52312 11.02348 10.33216 11.91914 13.66731 13.93949 16.71332 17.01327 15.03499 14.47763 14.38019 14.41362 15.83647 15.67047 14.47045 14.31423 14.19904 14.82268 14.1559 10.63981 10.66823 10.20522 11.10935 11.52312 11.02348 10.33216 11.91914 13.66731 13.93949 16.71332 17.01327 15.03499 14.47763 14.38019 14.41362 15.83647 15.67047 14.47045 14.31423 14.19904 14.82268 14.1559
8.488654 10.10538 10.92675 10.09366 10.85918 11.26827 12.20304 11.80998 13.27558 13.73623 16.86435 16.49012 14.37312 13.21352 13.43559 13.28338 14.71591 15.0856 14.91768 13.89271 13.95088 14.00357 13.01124 8.488654 10.10538 10.92675 10.09366 10.85918 11.26827 12.20304 11.80998 13.27558 13.73623 16.86435 16.49012 14.37312 13.21352 13.43559 13.28338 14.71591 15.0856 14.91768 13.89271 13.95088 14.00356 13.01124
10.81898 13.143 12.69162 12.18221 12.55161 11.64523 12.4468 13.02303 11.64384 13.77602 16.63419 16.27282 14.54465 12.69009 12.62936 13.17467 13.86224 14.07909 14.24895 13.57493 13.15678 13.56058 14.07112 10.81898 13.143 12.69162 12.18221 12.55161 11.64523 12.4468 13.02303 11.64384 13.77602 16.63419 16.27282 14.54465 12.69009 12.62936 13.17467 13.86224 14.07909 14.24895 13.57493 13.15678 13.56058 14.07112
11.59634 16.15282 16.04291 14.96902 14.3159 12.56915 13.37283 13.76863 13.54054 15.07096 17.31351 15.84202 14.1527 12.01037 12.44869 12.54331 13.90306 14.87695 13.81047 14.15678 13.85537 13.21027 14.43797 11.59634 16.15282 16.04291 14.96902 14.3159 12.56915 13.37283 13.76863 13.54054 15.07096 17.31351 15.84202 14.1527 12.01037 12.44869 12.54331 13.90306 14.87695 13.81047 14.15678 13.85537 13.21027 14.43797
11.50468 16.01534 15.65023 16.86644 16.7308 13.15539 13.75249 14.19167 14.84136 15.6804 16.669 15.56741 13.27599 12.18581 12.46388 13.30746 14.70786 14.89385 13.59378 14.1329 13.90083 13.44039 14.82801 11.50468 16.01534 15.65023 16.86644 16.7308 13.15539 13.75249 14.19167 14.84136 15.6804 16.669 15.56741 13.27599 12.18581 12.46388 13.30746 14.70786 14.89385 13.59378 14.1329 13.90083 13.44039 14.82801
...@@ -629,7 +629,7 @@ BAC009S0768W0290 [ ...@@ -629,7 +629,7 @@ BAC009S0768W0290 [
7.140229 7.340988 9.690434 11.22617 10.54758 9.907132 10.23349 7.846205 7.38694 7.756484 8.138117 7.949685 8.286037 7.875541 8.682808 9.680047 8.736238 9.250605 9.806664 9.929686 10.29157 10.88262 10.53922 7.140229 7.340988 9.690434 11.22617 10.54758 9.907132 10.23349 7.846205 7.38694 7.756484 8.138117 7.949685 8.286037 7.875541 8.682808 9.680047 8.736238 9.250605 9.806664 9.929686 10.29157 10.88262 10.53922
7.609503 8.446361 7.927704 10.19232 9.981958 9.750368 10.16796 8.132822 7.723164 7.520811 7.855199 7.349501 7.666749 8.55197 8.498571 9.580915 9.49983 9.968874 9.624427 10.19383 9.79729 10.48853 10.77697 7.609503 8.446361 7.927704 10.19232 9.981958 9.750368 10.16796 8.132822 7.723164 7.520811 7.855199 7.349501 7.666749 8.55197 8.498571 9.580915 9.49983 9.968874 9.624427 10.19383 9.79729 10.48853 10.77697
8.643137 8.622834 9.379179 10.04107 10.14056 9.3327 9.441696 7.66965 6.918215 7.325087 8.433827 7.403569 7.932473 9.355262 8.961336 9.433534 8.987287 9.442863 9.373944 9.75194 9.910201 10.3459 10.44656 8.643137 8.622834 9.379179 10.04107 10.14056 9.3327 9.441696 7.66965 6.918215 7.325087 8.433827 7.403569 7.932473 9.355262 8.961336 9.433534 8.987287 9.442863 9.373944 9.75194 9.910201 10.3459 10.44656
8.102217 8.064889 10.64028 12.49552 11.73663 10.07672 9.110008 8.321954 7.095238 7.711002 7.663853 7.130478 7.74688 9.022202 9.092591 9.239534 9.148391 9.078291 9.648328 9.942705 10.50384 10.56971 10.62924 8.102217 8.064889 10.64028 12.49552 11.73663 10.07672 9.110008 8.321954 7.095238 7.711002 7.663853 7.130478 7.74688 9.022202 9.092591 9.239534 9.148391 9.078291 9.648328 9.942706 10.50384 10.56971 10.62924
9.490426 8.373809 10.40654 12.21494 12.46647 10.44266 9.246642 8.188566 7.077143 7.664156 7.372887 8.266142 8.489851 8.568101 8.872865 9.148156 8.987501 9.957211 10.15845 9.909985 10.00002 10.26888 11.01089 9.490426 8.373809 10.40654 12.21494 12.46647 10.44266 9.246642 8.188566 7.077143 7.664156 7.372887 8.266142 8.489851 8.568101 8.872865 9.148156 8.987501 9.957211 10.15845 9.909985 10.00002 10.26888 11.01089
8.798372 9.025386 11.31425 11.42679 10.40138 9.216152 9.422606 8.502447 7.214077 7.507916 7.581383 7.426453 7.74972 8.678537 8.401515 9.35175 9.522068 9.689368 10.34969 10.18144 10.10829 10.22423 10.66045 8.798372 9.025386 11.31425 11.42679 10.40138 9.216152 9.422606 8.502447 7.214077 7.507916 7.581383 7.426453 7.74972 8.678537 8.401515 9.35175 9.522068 9.689368 10.34969 10.18144 10.10829 10.22423 10.66045
8.333779 8.557695 11.21921 11.96504 10.46627 9.176018 9.10099 8.930181 6.847103 7.599282 7.893191 7.544654 8.840031 8.585423 8.405005 8.922948 9.007273 9.288807 9.946635 10.77755 10.62705 10.41732 10.66157 8.333779 8.557695 11.21921 11.96504 10.46627 9.176018 9.10099 8.930181 6.847103 7.599282 7.893191 7.544654 8.840031 8.585423 8.405005 8.922948 9.007273 9.288807 9.946635 10.77755 10.62705 10.41732 10.66157
...@@ -738,7 +738,7 @@ BAC009S0768W0290 [ ...@@ -738,7 +738,7 @@ BAC009S0768W0290 [
14.37599 16.83687 16.94507 18.2267 16.84422 18.06699 18.55002 15.54701 16.76327 16.83081 17.27568 17.00946 16.32395 15.44895 15.63621 15.85781 16.74874 15.47261 13.73446 15.28013 15.02808 14.89976 16.14604 14.37599 16.83687 16.94507 18.2267 16.84422 18.06699 18.55002 15.54701 16.76327 16.83081 17.27568 17.00946 16.32395 15.44895 15.63621 15.85781 16.74874 15.47261 13.73446 15.28013 15.02808 14.89976 16.14604
15.05994 16.78429 17.38232 18.71122 17.29902 17.89909 18.18792 17.06817 16.19571 16.4189 16.93696 17.02257 16.01795 15.9466 15.9529 16.66254 17.07906 14.79625 13.80007 15.45906 15.62278 14.89583 16.3634 15.05994 16.78429 17.38232 18.71122 17.29902 17.89909 18.18792 17.06817 16.19571 16.4189 16.93696 17.02257 16.01795 15.9466 15.9529 16.66254 17.07906 14.79625 13.80007 15.45906 15.62278 14.89583 16.3634
15.31985 17.11125 16.90094 17.50673 18.12416 17.26594 18.61826 17.81363 16.92988 17.33131 17.22307 17.6853 17.16475 17.8327 17.79674 18.01369 18.75657 16.41342 14.83692 16.64419 17.08493 16.10439 17.74908 15.31985 17.11125 16.90094 17.50673 18.12416 17.26594 18.61826 17.81363 16.92988 17.33131 17.22307 17.6853 17.16475 17.8327 17.79674 18.01369 18.75657 16.41342 14.83692 16.64419 17.08493 16.10439 17.74908
14.81287 16.67113 17.24438 17.58853 16.56671 17.4409 19.14317 17.1272 17.22141 17.37194 17.30178 17.35553 16.81259 17.59592 17.2289 17.99676 18.54756 16.97488 15.1711 17.01239 17.41453 16.61493 18.02878 14.81287 16.67113 17.24438 17.58853 16.56671 17.4409 19.14317 17.1272 17.22141 17.37194 17.30178 17.35553 16.81259 17.59592 17.2289 17.99676 18.54756 16.97488 15.1711 17.01239 17.41453 16.61493 18.02877
14.10214 16.48185 16.70473 17.83863 17.09863 17.92168 18.60074 17.03748 17.01916 17.1662 17.45386 16.9503 17.22705 17.88758 17.25076 18.06163 18.82708 17.06891 15.6639 17.32082 17.86867 16.99368 18.4935 14.10214 16.48185 16.70473 17.83863 17.09863 17.92168 18.60074 17.03748 17.01916 17.1662 17.45386 16.9503 17.22705 17.88758 17.25076 18.06163 18.82708 17.06891 15.6639 17.32082 17.86867 16.99368 18.4935
14.47095 16.27239 17.20447 16.68737 16.69925 16.92639 17.55458 16.4129 16.37072 16.70506 17.13801 16.74328 16.66209 17.66596 17.03108 17.52262 18.5179 16.57609 15.3233 16.59836 16.57953 15.76227 17.69633 14.47095 16.27239 17.20447 16.68737 16.69925 16.92639 17.55458 16.4129 16.37072 16.70506 17.13801 16.74328 16.66209 17.66596 17.03108 17.52262 18.5179 16.57609 15.3233 16.59836 16.57953 15.76227 17.69633
13.24856 14.56392 16.16074 15.96923 16.11824 17.0615 17.37887 16.89696 16.49023 16.93359 17.04477 16.61666 17.3206 18.46787 17.4531 17.96162 19.10358 16.9934 15.63334 17.35444 17.27749 16.49334 18.51469 13.24856 14.56392 16.16074 15.96923 16.11824 17.0615 17.37887 16.89696 16.49023 16.93359 17.04477 16.61666 17.3206 18.46787 17.4531 17.96162 19.10358 16.9934 15.63334 17.35444 17.27749 16.49334 18.51469
...@@ -762,7 +762,7 @@ BAC009S0768W0290 [ ...@@ -762,7 +762,7 @@ BAC009S0768W0290 [
11.11114 12.00806 12.1118 11.56301 11.28773 11.11582 11.11947 10.14109 9.354194 9.394133 8.459903 9.571765 10.62552 10.94563 10.39587 10.17176 11.07636 10.36478 10.18448 10.5289 10.58135 11.55 12.22885 11.11114 12.00806 12.1118 11.56301 11.28773 11.11582 11.11947 10.14109 9.354194 9.394133 8.459903 9.571765 10.62552 10.94563 10.39587 10.17176 11.07636 10.36478 10.18448 10.5289 10.58135 11.55 12.22885
9.4698 10.58114 11.28397 11.78697 11.88663 11.19909 11.94986 8.947301 8.886659 9.0145 8.525748 9.001356 10.4408 10.03337 9.662758 9.838831 10.64479 9.835432 9.941095 11.35219 12.8765 13.6802 13.69769 9.4698 10.58114 11.28397 11.78697 11.88663 11.19909 11.94986 8.947301 8.886659 9.0145 8.525748 9.001356 10.4408 10.03337 9.662758 9.838831 10.64479 9.835432 9.941095 11.35219 12.8765 13.6802 13.69769
9.431818 10.37749 9.402466 11.65605 12.08712 11.54609 11.73875 8.867339 9.922234 10.61318 10.76134 10.87708 10.16173 10.49702 11.13492 10.97119 10.87446 9.942475 10.69347 12.76756 14.78555 15.63049 15.3683 9.431818 10.37749 9.402466 11.65605 12.08712 11.54609 11.73875 8.867339 9.922234 10.61318 10.76134 10.87708 10.16173 10.49702 11.13492 10.97119 10.87446 9.942475 10.69347 12.76756 14.78555 15.63049 15.3683
9.377582 10.94667 11.15134 12.46202 11.73515 10.88063 11.25175 9.65536 11.14065 11.88232 11.94413 11.89391 10.90223 11.40995 12.1747 11.62114 11.59762 10.78957 11.37593 13.46099 15.81433 17.16357 17.15998 9.377582 10.94667 11.15134 12.46202 11.73515 10.88063 11.25175 9.65536 11.14065 11.88232 11.94413 11.89391 10.90223 11.40995 12.1747 11.62114 11.59762 10.78957 11.37593 13.46099 15.81433 17.16356 17.15998
9.576265 11.13453 10.96931 10.33049 10.23858 10.44758 10.76839 8.92027 9.525447 10.34433 9.90531 9.858282 9.904203 11.16824 11.88748 11.96853 11.37809 11.49845 11.76391 14.43392 16.65162 18.26472 17.6829 9.576265 11.13453 10.96931 10.33049 10.23858 10.44758 10.76839 8.92027 9.525447 10.34433 9.90531 9.858282 9.904203 11.16824 11.88748 11.96853 11.37809 11.49845 11.76391 14.43392 16.65162 18.26472 17.6829
9.068971 10.9832 11.37302 11.22971 9.851135 9.574883 9.735991 9.078069 9.105554 10.11883 10.55576 10.29943 9.432137 11.80125 12.00973 12.56134 12.2724 12.0964 12.37772 14.91978 17.71165 19.49631 18.86863 9.068971 10.9832 11.37302 11.22971 9.851135 9.574883 9.735991 9.078069 9.105554 10.11883 10.55576 10.29943 9.432137 11.80125 12.00973 12.56134 12.2724 12.0964 12.37772 14.91978 17.71165 19.49631 18.86863
10.06087 11.30585 10.13232 9.214253 8.846772 9.325168 10.23292 9.699574 10.61134 11.65377 12.32304 11.8669 11.56203 13.31346 13.75598 14.85218 14.10346 13.62769 13.95514 16.67099 18.7434 19.90597 20.01846 10.06087 11.30585 10.13232 9.214253 8.846772 9.325168 10.23292 9.699574 10.61134 11.65377 12.32304 11.8669 11.56203 13.31346 13.75598 14.85218 14.10346 13.62769 13.95514 16.67099 18.7434 19.90597 20.01846
...@@ -810,7 +810,7 @@ BAC009S0768W0290 [ ...@@ -810,7 +810,7 @@ BAC009S0768W0290 [
10.57615 17.0614 17.78706 16.76842 18.19138 17.44588 18.12214 14.26881 15.37736 17.35711 17.82368 16.12888 14.66693 15.406 15.11084 16.10291 17.21349 14.85879 14.25072 15.92479 15.79147 15.51069 17.19426 10.57615 17.0614 17.78706 16.76842 18.19138 17.44588 18.12214 14.26881 15.37736 17.35711 17.82368 16.12888 14.66693 15.406 15.11084 16.10291 17.21349 14.85879 14.25072 15.92479 15.79147 15.51069 17.19426
9.48652 16.911 17.18489 17.25456 18.75069 18.27182 18.70464 15.1519 15.75929 18.05139 18.79077 18.19505 14.61217 15.21042 14.50809 16.6024 17.5759 14.97376 14.62691 15.54537 15.83502 14.67196 16.36763 9.48652 16.911 17.18489 17.25456 18.75069 18.27182 18.70464 15.1519 15.75929 18.05139 18.79077 18.19505 14.61217 15.21042 14.50809 16.6024 17.5759 14.97376 14.62691 15.54537 15.83502 14.67196 16.36763
9.985225 16.74782 17.24112 17.25887 18.27095 18.51624 18.83493 16.13771 15.24101 18.14103 19.13589 18.64982 14.49468 13.72041 14.16209 16.20668 16.41984 14.58272 14.20643 15.07785 16.00739 15.01148 16.37612 9.985225 16.74782 17.24112 17.25887 18.27095 18.51624 18.83493 16.13771 15.24101 18.14103 19.13589 18.64982 14.49468 13.72041 14.16209 16.20668 16.41984 14.58272 14.20643 15.07785 16.00739 15.01148 16.37612
8.453218 16.44852 16.53209 17.24354 18.39434 18.03302 18.01833 17.08058 14.58579 18.43371 19.00238 18.1741 14.07615 12.95393 12.84746 15.36702 15.92542 14.33508 13.597 14.46982 16.11521 14.52892 17.01237 8.453218 16.44852 16.53209 17.24354 18.39434 18.03302 18.01833 17.08058 14.58579 18.43371 19.00238 18.1741 14.07615 12.95393 12.84746 15.36702 15.92542 14.33508 13.597 14.46982 16.11521 14.52893 17.01237
9.352406 16.0076 16.35685 16.47454 16.98188 17.873 17.68334 17.51781 14.67671 18.76287 18.72811 17.72148 13.38931 12.69698 13.39213 14.65827 15.30858 15.00858 14.27974 14.66115 15.79502 13.98777 16.22205 9.352406 16.0076 16.35685 16.47454 16.98188 17.873 17.68334 17.51781 14.67671 18.76287 18.72811 17.72148 13.38931 12.69698 13.39213 14.65827 15.30858 15.00858 14.27974 14.66115 15.79502 13.98777 16.22205
9.672524 14.51215 14.49281 17.57202 18.71115 18.5533 18.56325 18.01528 15.20035 18.96259 18.58512 17.13366 13.41415 12.05879 12.61457 14.21013 14.71272 14.4392 14.22963 14.40962 15.35258 14.32724 15.84399 9.672524 14.51215 14.49281 17.57202 18.71115 18.5533 18.56325 18.01528 15.20035 18.96259 18.58512 17.13366 13.41415 12.05879 12.61457 14.21013 14.71272 14.4392 14.22963 14.40962 15.35258 14.32724 15.84399
9.294844 14.85708 15.12689 17.73894 18.71831 18.47003 18.26656 17.68312 15.53754 18.16326 17.79104 15.80158 12.8884 11.75445 11.60362 14.12353 14.61159 13.81479 13.50152 14.23705 15.36493 14.26479 16.47873 9.294844 14.85708 15.12689 17.73894 18.71831 18.47003 18.26656 17.68312 15.53754 18.16326 17.79104 15.80158 12.8884 11.75445 11.60362 14.12353 14.61159 13.81479 13.50152 14.23705 15.36493 14.26479 16.47873
......
BAC009S0768W0290 [ test_wav [
0.4300044 238.1164 0.4300044 238.1164
0.7310953 238.1164 0.7310953 238.1164
0.0589752 238.1164 0.0589752 238.1164
0.3706925 238.1164 0.3706925 238.1164
0.635388 238.1164 0.6353879 238.1164
0.4168843 238.1164 0.4168843 238.1164
0.7615743 238.1164 0.7615743 238.1164
0.7359886 238.1164 0.7359886 238.1164
...@@ -11,25 +11,25 @@ BAC009S0768W0290 [ ...@@ -11,25 +11,25 @@ BAC009S0768W0290 [
0.843815 238.1164 0.843815 238.1164
0.574707 238.1164 0.574707 238.1164
0.8757079 238.1164 0.8757079 238.1164
0.8545786 238.1164 0.8545787 238.1164
0.5284879 238.1164 0.5284878 238.1164
0.8398616 238.1164 0.8398617 238.1164
0.8405749 238.1164 0.8405749 238.1164
0.7291092 238.1164 0.7291093 238.1164
0.3530312 238.1164 0.3530312 238.1164
0.8516903 238.1164 0.8516902 238.1164
0.8366287 238.1164 0.8366287 238.1164
0.7860549 238.1164 0.7860549 238.1164
0.7996265 238.1164 0.7996263 238.1164
0.8769379 238.1164 0.8769377 238.1164
0.8062987 238.1164 0.8062987 238.1164
0.5502667 238.1164 0.5502667 238.1164
0.8050084 236.9318 0.8050084 236.9318
0.8435217 235.753 0.8435217 235.753
0.6781067 234.5801 0.6781067 234.5801
0.6275977 233.4131 0.6275977 233.4131
0.8354952 232.2518 0.8354951 232.2518
0.7898549 231.0963 0.7898548 231.0963
0.6786529 229.9466 0.6786529 229.9466
0.5784115 228.8026 0.5784115 228.8026
0.8078744 227.6642 0.8078744 227.6642
...@@ -38,17 +38,17 @@ BAC009S0768W0290 [ ...@@ -38,17 +38,17 @@ BAC009S0768W0290 [
0.7398534 224.2832 0.7398534 224.2832
0.7554479 223.1673 0.7554479 223.1673
0.3688865 222.057 0.3688865 222.057
0.4319391 220.9523 0.431939 220.9523
-0.2559482 219.853 -0.2559481 219.853
0.516133 218.7592 0.5161331 218.7592
0.736354 217.6709 0.736354 217.6709
0.2649689 216.5879 0.2649688 216.5879
0.6187224 215.5104 0.6187224 215.5104
0.8040497 214.4382 0.8040497 214.4382
0.4176693 213.3714 0.4176693 213.3714
0.7362868 212.3098 0.7362868 212.3098
0.6412426 211.2535 0.6412426 211.2535
0.01994591 210.2025 0.01994592 210.2025
-0.09901931 209.1568 -0.09901931 209.1568
0.4139394 208.1162 0.4139394 208.1162
0.7458671 207.0808 0.7458671 207.0808
...@@ -58,21 +58,21 @@ BAC009S0768W0290 [ ...@@ -58,21 +58,21 @@ BAC009S0768W0290 [
0.9370709 212.3098 0.9370709 212.3098
0.9640602 216.5879 0.9640602 216.5879
0.9851464 217.6709 0.9851464 217.6709
0.9874666 217.6709 0.9874667 217.6709
0.9662011 215.5104 0.9662011 215.5104
0.9561557 211.2535 0.9561557 211.2535
0.9835508 209.1568 0.9835509 209.1568
0.9764188 209.1568 0.9764188 209.1568
0.8779365 208.1162 0.8779365 208.1162
0.8911879 207.0808 0.8911879 207.0808
0.8716732 205.0254 0.8716732 205.0254
0.8663443 197.9909 0.8663442 197.9909
0.9105747 191.1978 0.9105747 191.1978
0.9614732 191.1978 0.9614732 191.1978
0.9704161 187.4211 0.9704162 187.4211
0.9690548 186.4887 0.9690547 186.4887
0.9596871 187.4211 0.9596871 187.4211
0.9392475 190.2465 0.9392474 190.2465
0.8951484 192.1537 0.8951484 192.1537
0.8852764 190.2465 0.8852764 190.2465
0.9345272 185.5609 0.9345272 185.5609
...@@ -82,66 +82,66 @@ BAC009S0768W0290 [ ...@@ -82,66 +82,66 @@ BAC009S0768W0290 [
0.9876611 178.3027 0.9876611 178.3027
0.9889374 178.3027 0.9889374 178.3027
0.9911457 178.3027 0.9911457 178.3027
0.9835687 176.533 0.9835688 176.533
0.9755108 175.6547 0.9755108 175.6547
0.9868198 174.7808 0.9868198 174.7808
0.9932452 175.6547 0.9932452 175.6547
0.9902206 175.6547 0.9902206 175.6547
0.9920143 176.533 0.9920143 176.533
0.9922132 175.6547 0.9922135 175.6547
0.9892406 174.7808 0.9892406 174.7808
0.9888866 172.185 0.9888865 172.185
0.9796383 172.185 0.9796383 172.185
0.9825095 170.476 0.9825094 170.476
0.9640273 170.476 0.9640273 170.476
0.9416605 173.046 0.9416605 173.046
0.9690976 173.9112 0.9690976 173.9112
0.9527847 173.9112 0.9527848 173.9112
0.8625391 173.046 0.8625391 173.046
0.8571137 173.9112 0.8571138 173.9112
0.826855 174.7808 0.826855 174.7808
0.804625 176.533 0.8046249 176.533
0.6064063 178.3027 0.6064064 178.3027
0.4831207 180.9906 0.4831207 180.9906
0.4654697 183.7191 0.4654697 183.7191
0.6392145 186.4887 0.6392145 186.4887
0.6342434 190.2465 0.6342434 190.2465
0.8626601 194.0801 0.8626602 194.0801
0.953752 194.0801 0.953752 194.0801
0.987371 191.1978 0.987371 191.1978
0.9915443 188.3582 0.9915444 188.3582
0.9920763 186.4887 0.9920763 186.4887
0.9898384 184.6377 0.9898383 184.6377
0.9908906 181.8956 0.9908906 181.8956
0.9892344 180.9906 0.9892344 180.9906
0.9779232 179.1942 0.9779232 179.1942
0.9628869 175.6547 0.962887 175.6547
0.9623674 170.476 0.9623674 170.476
0.9719465 171.3284 0.9719465 171.3284
0.9843822 173.046 0.9843823 173.046
0.9776363 173.9112 0.9776363 173.9112
0.9711901 173.9112 0.9711902 173.9112
0.9477385 172.185 0.9477384 172.185
0.9629892 172.185 0.9629893 172.185
0.9716213 173.9112 0.9716213 173.9112
0.9675733 176.533 0.9675733 176.533
0.9643332 178.3027 0.9643332 178.3027
0.9592765 180.0902 0.9592766 180.0902
0.8798138 181.8956 0.8798139 181.8956
0.7133937 185.5609 0.7133937 185.5609
0.5589979 190.2465 0.558998 190.2465
0.3460311 196.0257 0.3460312 196.0257
0.645723 201.9805 0.645723 201.9805
0.5388261 208.1162 0.538826 208.1162
0.6076745 216.5879 0.6076745 216.5879
0.5921854 228.8026 0.5921855 228.8026
0.8826846 238.1164 0.8826846 238.1164
0.9501733 242.9146 0.9501736 242.9146
0.9898382 245.3498 0.9898381 245.3498
0.9941773 245.3498 0.9941772 245.3498
0.9901066 246.5766 0.9901065 246.5766
0.9880083 247.8095 0.9880084 247.8095
0.9941742 249.0485 0.9941741 249.0485
0.9959649 249.0485 0.9959649 249.0485
0.9930359 250.2938 0.9930359 250.2938
0.9856881 252.8029 0.9856881 252.8029
...@@ -150,7 +150,7 @@ BAC009S0768W0290 [ ...@@ -150,7 +150,7 @@ BAC009S0768W0290 [
0.9980655 252.8029 0.9980655 252.8029
0.9958057 251.5452 0.9958057 251.5452
0.9909865 250.2938 0.9909865 250.2938
0.9907232 249.0485 0.990723 249.0485
0.987911 249.0485 0.987911 249.0485
0.9759061 251.5452 0.9759061 251.5452
0.9722236 251.5452 0.9722236 251.5452
...@@ -161,8 +161,8 @@ BAC009S0768W0290 [ ...@@ -161,8 +161,8 @@ BAC009S0768W0290 [
0.6358631 218.7592 0.6358631 218.7592
0.757064 198.9809 0.757064 198.9809
0.8944787 192.1537 0.8944787 192.1537
0.9415625 188.3582 0.9415626 188.3582
0.9400395 183.7191 0.9400396 183.7191
0.9019431 180.9906 0.9019431 180.9906
0.904547 175.6547 0.904547 175.6547
0.8742625 173.046 0.8742625 173.046
...@@ -175,37 +175,37 @@ BAC009S0768W0290 [ ...@@ -175,37 +175,37 @@ BAC009S0768W0290 [
0.3527509 136.2042 0.3527509 136.2042
0.191848 130.2255 0.191848 130.2255
0.3072545 128.2915 0.3072545 128.2915
0.5506753 127.0181 0.5506754 127.0181
0.6923887 129.5776 0.6923887 129.5776
0.6101584 132.8496 0.6101584 132.8496
0.3040283 138.2575 0.3040284 138.2575
0.1897903 155.8383 0.1897903 155.8383
0.4685728 164.6269 0.4685728 164.6269
0.5444003 164.6269 0.5444003 164.6269
0.5138597 162.9929 0.5138596 162.9929
0.5802025 160.5723 0.5802024 160.5723
0.2090085 160.5723 0.2090085 160.5723
0.2416739 162.9929 0.2416739 162.9929
0.2459604 168.784 0.2459603 168.784
0.6345571 176.533 0.6345571 176.533
0.5914032 184.6377 0.5914032 184.6377
0.4447053 193.1145 0.4447052 193.1145
0.2762254 201.9805 0.2762254 201.9805
0.2842087 212.3098 0.2842087 212.3098
-0.1974148 224.2832 -0.1974148 224.2832
0.5095772 238.1164 0.5095772 238.1164
0.7442542 252.8029 0.7442543 252.8029
0.8915138 252.8029 0.8915138 252.8029
0.9569594 247.8095 0.9569594 247.8095
0.9625007 242.9146 0.9625007 242.9146
0.9194686 235.753 0.9194686 235.753
0.8994824 227.6642 0.8994824 227.6642
0.9381442 218.7592 0.9381443 218.7592
0.7226841 219.853 0.7226841 219.853
0.6949252 223.1673 0.6949252 223.1673
0.6777955 222.057 0.6777956 222.057
0.7978759 214.4382 0.7978759 214.4382
0.850777 209.1568 0.8507771 209.1568
0.7713854 211.2535 0.7713854 211.2535
0.6789038 211.2535 0.6789038 211.2535
0.7500904 206.0505 0.7500904 206.0505
...@@ -217,11 +217,11 @@ BAC009S0768W0290 [ ...@@ -217,11 +217,11 @@ BAC009S0768W0290 [
0.6536841 193.1145 0.6536841 193.1145
0.7034875 188.3582 0.7034875 188.3582
0.5804744 181.8956 0.5804744 181.8956
0.4417493 173.046 0.4417492 173.046
0.3494109 161.3751 0.3494109 161.3751
0.1981726 148.2564 0.1981726 148.2564
0.6261529 140.3417 0.6261529 140.3417
0.758739 136.8852 0.7587391 136.8852
0.3861219 134.8523 0.3861219 134.8523
0.2585415 138.2575 0.2585415 138.2575
0.4469885 141.7487 0.4469885 141.7487
...@@ -234,13 +234,13 @@ BAC009S0768W0290 [ ...@@ -234,13 +234,13 @@ BAC009S0768W0290 [
0.2834992 149.7427 0.2834992 149.7427
0.4845652 151.2439 0.4845652 151.2439
0.4879717 151.2439 0.4879717 151.2439
0.5601907 152.0001 0.5601908 152.0001
0.7019184 152.0001 0.7019184 152.0001
0.8482625 152.0001 0.8482625 152.0001
0.8672082 152.0001 0.8672082 152.0001
0.8626108 151.2439 0.8626106 151.2439
0.8626055 149.7427 0.8626055 149.7427
0.901338 148.2564 0.9013379 148.2564
0.8793075 146.7849 0.8793075 146.7849
0.8914734 144.605 0.8914734 144.605
0.8311929 141.7487 0.8311929 141.7487
...@@ -256,12 +256,12 @@ BAC009S0768W0290 [ ...@@ -256,12 +256,12 @@ BAC009S0768W0290 [
0.1688575 132.1886 0.1688575 132.1886
0.2404094 136.8852 0.2404094 136.8852
0.161655 139.6435 0.161655 139.6435
0.3617381 140.3417 0.361738 140.3417
-0.02500388 138.2575 -0.02500387 138.2575
0.4358978 136.2042 0.4358978 136.2042
0.4791997 134.8523 0.4791997 134.8523
0.5491226 134.1814 0.5491226 134.1814
0.6218377 133.5138 0.6218376 133.5138
0.566164 133.5138 0.566164 133.5138
0.6004029 134.1814 0.6004029 134.1814
0.4282176 134.8523 0.4282176 134.8523
...@@ -282,10 +282,10 @@ BAC009S0768W0290 [ ...@@ -282,10 +282,10 @@ BAC009S0768W0290 [
0.7003101 153.5239 0.7003101 153.5239
0.7147154 155.8383 0.7147154 155.8383
0.7900128 158.9785 0.7900128 158.9785
0.7915135 160.5723 0.7915136 160.5723
0.8635668 162.9929 0.8635668 162.9929
0.915316 167.1087 0.9153162 167.1087
0.9632363 168.784 0.9632365 168.784
0.9837555 173.046 0.9837555 173.046
0.9895447 174.7808 0.9895447 174.7808
0.9936979 178.3027 0.9936979 178.3027
...@@ -293,28 +293,28 @@ BAC009S0768W0290 [ ...@@ -293,28 +293,28 @@ BAC009S0768W0290 [
0.9943298 180.9906 0.9943298 180.9906
0.9935455 183.7191 0.9935455 183.7191
0.9959602 184.6377 0.9959602 184.6377
0.9956326 184.6377 0.9956325 184.6377
0.9592335 185.5609 0.9592334 185.5609
0.8768551 189.3 0.8768551 189.3
0.7307227 193.1145 0.7307228 193.1145
0.5111329 192.1537 0.511133 192.1537
0.6857247 188.3582 0.6857247 188.3582
0.9158596 184.6377 0.9158598 184.6377
0.9108561 186.4887 0.9108561 186.4887
0.9116814 187.4211 0.9116812 187.4211
0.9223366 187.4211 0.9223366 187.4211
0.8974369 188.3582 0.8974369 188.3582
0.8092315 189.3 0.8092315 189.3
0.6424754 190.2465 0.6424754 190.2465
0.415496 193.1145 0.415496 193.1145
-0.09486373 194.0801 -0.09486372 194.0801
0.06201402 196.0257 0.06201403 196.0257
0.7022306 199.9758 0.7022306 199.9758
0.8596367 206.0505 0.8596367 206.0505
0.8891435 212.3098 0.8891434 212.3098
0.8837854 220.9523 0.8837855 220.9523
0.7532349 229.9466 0.7532349 229.9466
0.8273477 235.753 0.8273478 235.753
0.8926229 240.5036 0.8926229 240.5036
0.9618158 242.9146 0.9618158 242.9146
0.9802947 242.9146 0.9802947 242.9146
...@@ -324,144 +324,144 @@ BAC009S0768W0290 [ ...@@ -324,144 +324,144 @@ BAC009S0768W0290 [
0.8714783 222.057 0.8714783 222.057
0.6913882 217.6709 0.6913882 217.6709
0.5996734 214.4382 0.5996734 214.4382
0.5818066 196.0257 0.5818065 196.0257
0.734632 182.8051 0.7346321 182.8051
0.8720678 184.6377 0.8720678 184.6377
0.8043495 181.8956 0.8043494 181.8956
0.7913815 184.6377 0.7913815 184.6377
0.8019897 179.1942 0.8019897 179.1942
0.8272967 177.4156 0.8272967 177.4156
0.917188 173.9112 0.917188 173.9112
0.948779 178.3027 0.948779 178.3027
0.9491397 179.1942 0.9491397 179.1942
0.9660938 181.8956 0.9660939 181.8956
0.9489249 181.8956 0.948925 181.8956
0.9438759 183.7191 0.9438759 183.7191
0.9082419 182.8051 0.9082419 182.8051
0.8157918 182.8051 0.8157918 182.8051
0.7726267 183.7191 0.7726267 183.7191
0.7925529 184.6377 0.7925529 184.6377
0.82323 185.5609 0.82323 185.5609
0.7710456 186.4887 0.7710455 186.4887
0.7245523 187.4211 0.7245523 187.4211
0.6725792 188.3582 0.6725792 188.3582
0.6098945 190.2465 0.6098945 190.2465
0.6053364 192.1537 0.6053364 192.1537
0.5669799 194.0801 0.5669799 194.0801
0.6425812 196.0257 0.6425812 196.0257
0.5920787 198.9809 0.5920788 198.9809
0.5982968 201.9805 0.5982969 201.9805
0.5845768 206.0505 0.5845767 206.0505
0.8673239 210.2025 0.8673239 210.2025
0.8958703 213.3714 0.8958703 213.3714
0.9322492 215.5104 0.9322492 215.5104
0.9763455 216.5879 0.9763456 216.5879
0.9871498 217.6709 0.9871499 217.6709
0.9847116 216.5879 0.9847117 216.5879
0.9803718 215.5104 0.9803717 215.5104
0.9864718 214.4382 0.9864718 214.4382
0.9891353 213.3714 0.9891353 213.3714
0.9886543 212.3098 0.9886542 212.3098
0.9887235 211.2535 0.9887235 211.2535
0.9895413 211.2535 0.9895412 211.2535
0.987739 210.2025 0.987739 210.2025
0.9813523 211.2535 0.9813522 211.2535
0.979372 210.2025 0.979372 210.2025
0.9715058 211.2535 0.9715059 211.2535
0.9659958 212.3098 0.9659958 212.3098
0.9582936 213.3714 0.9582934 213.3714
0.9457313 214.4382 0.9457313 214.4382
0.9001305 214.4382 0.9001306 214.4382
0.8375491 214.4382 0.8375491 214.4382
0.8580287 213.3714 0.8580287 213.3714
0.8090529 212.3098 0.8090529 212.3098
0.7204516 211.2535 0.7204515 211.2535
0.727868 211.2535 0.727868 211.2535
0.8134795 211.2535 0.8134795 211.2535
0.7847017 212.3098 0.7847017 212.3098
0.855688 212.3098 0.855688 212.3098
0.9308019 212.3098 0.9308017 212.3098
0.8832354 211.2535 0.8832355 211.2535
0.7976366 210.2025 0.7976366 210.2025
0.6125829 208.1162 0.6125828 208.1162
0.7335693 206.0505 0.7335693 206.0505
0.5974885 204.0054 0.5974885 204.0054
0.5784881 201.9805 0.5784881 201.9805
0.626056 199.9758 0.626056 199.9758
0.3227087 197.9909 0.3227086 197.9909
0.4882276 196.0257 0.4882276 196.0257
0.5797763 194.0801 0.5797763 194.0801
0.6834005 191.1978 0.6834005 191.1978
0.8976591 190.2465 0.8976591 190.2465
0.9618267 188.3582 0.9618267 188.3582
0.9768699 185.5609 0.9768698 185.5609
0.9630268 181.8956 0.9630268 181.8956
0.951674 178.3027 0.951674 178.3027
0.9476837 173.9112 0.9476838 173.9112
0.9517155 172.185 0.9517156 172.185
0.950453 169.6279 0.9504529 169.6279
0.9870636 169.6279 0.9870636 169.6279
0.9741295 168.784 0.9741296 168.784
0.9508373 168.784 0.9508372 168.784
0.9088299 165.4501 0.90883 165.4501
0.8581914 161.3751 0.8581914 161.3751
0.8267853 156.6175 0.8267851 156.6175
0.6312259 150.4914 0.6312259 150.4914
0.5465251 146.7849 0.546525 146.7849
0.5260748 146.7849 0.5260749 146.7849
0.4342185 153.5239 0.4342186 153.5239
0.492891 160.5723 0.492891 160.5723
0.6401276 166.2773 0.6401276 166.2773
0.7607003 168.784 0.7607003 168.784
0.8006893 169.6279 0.8006893 169.6279
0.7544849 169.6279 0.754485 169.6279
0.3563844 168.784 0.3563844 168.784
0.2301813 168.784 0.2301813 168.784
0.5213931 168.784 0.5213931 168.784
0.4302804 169.6279 0.4302804 169.6279
0.203999 170.476 0.203999 170.476
0.5803608 172.185 0.5803608 172.185
0.8012798 173.046 0.799207 173.9112
0.7842259 174.7808 0.7838959 175.6547
0.6298392 176.533 0.6272278 177.4156
0.570219 178.3027 0.5649745 179.1942
0.1462309 180.0902 0.1334038 180.9906
0.4738916 181.8956 0.4665532 182.8051
0.7047339 183.7191 0.7017906 184.6377
0.5743412 185.5609 0.574991 186.4887
0.1738716 187.4211 0.1776394 188.3582
0.7062971 189.3 0.7058933 190.2465
0.7296951 191.1978 0.7285945 192.1537
0.5698892 193.1145 0.5696192 194.0801
0.5760642 195.0505 0.5714518 196.0257
0.8032525 197.9909 0.8047431 198.9809
0.7386044 199.9758 0.7406042 200.9756
0.3124306 201.9805 0.3201705 202.9904
0.7400995 204.0054 0.7420282 205.0254
0.81351 206.0505 0.8154832 207.0808
0.7292117 208.1162 0.7317356 209.1568
0.3050336 210.2025 0.3067544 211.2535
0.800931 212.3098 0.8014479 213.3714
0.80885 214.4382 0.8102676 215.5104
0.4383909 216.5879 0.4439816 217.6709
0.822098 218.7592 0.8234195 219.853
0.7869211 220.9523 0.7885534 222.057
0.4181414 223.1673 0.4245847 224.2832
-0.005411861 225.4046 0.00418177 226.5316
0.2980209 227.6642 0.3035149 228.8026
0.6524665 229.9466 0.6538261 231.0963
0.8465661 232.2518 0.847946 233.4131
0.6178842 234.5801 0.6219971 235.753
0.858582 236.9318 0.858582 236.9318
0.8284138 239.307 0.8284138 239.307
0.4044587 240.5036 0.4044586 240.5036
0.7807371 241.7061 0.7807371 241.7061
0.6421613 242.9146 0.6421613 242.9146
0.4366452 244.1292 0.4366452 244.1292
0.8172922 245.3498 0.8172922 245.3498
0.707725 246.5766 0.7077252 246.5766
0.7137164 247.8095 0.7137164 247.8095
0.8416378 249.0485 0.8416377 249.0485
0.8084357 250.2938 0.8084357 250.2938
0.6429872 251.5452 0.6429872 251.5452
0.8479958 252.8029 0.8479958 252.8029
...@@ -476,71 +476,71 @@ BAC009S0768W0290 [ ...@@ -476,71 +476,71 @@ BAC009S0768W0290 [
0.4621202 265.7313 0.4621202 265.7313
0.4633192 267.06 0.4633192 267.06
0.7247673 268.3953 0.7247673 268.3953
0.7581605 269.7372 0.7581604 269.7372
0.5511292 271.0859 0.5511292 271.0859
0.9282034 272.4414 0.9282034 272.4414
0.9706462 271.0859 0.9706463 271.0859
0.9854098 273.8036 0.9854098 273.8036
0.9971126 273.8036 0.9971125 273.8036
0.9954729 272.4414 0.9954729 272.4414
0.9888761 269.7372 0.9888761 269.7372
0.9950761 267.06 0.9950762 267.06
0.996837 269.7372 0.9968371 269.7372
0.9980098 269.7372 0.9980098 269.7372
0.997749 268.3953 0.997749 268.3953
0.9915248 265.7313 0.9915248 265.7313
0.9653835 259.1866 0.9653835 259.1866
0.9663865 256.614 0.9663866 256.614
0.9707377 259.1866 0.9707376 259.1866
0.9852749 263.0938 0.9852746 263.0938
0.982106 265.7313 0.982106 265.7313
0.9469596 267.06 0.9469596 267.06
0.9675582 264.4093 0.9675582 264.4093
0.9636478 261.7849 0.9636477 261.7849
0.9427547 257.8971 0.9427549 257.8971
0.7895892 251.5452 0.7895892 251.5452
0.8654758 245.3498 0.8654758 245.3498
0.5468963 235.753 0.5468963 235.753
0.683558 220.9523 0.683558 220.9523
0.8124123 211.2535 0.8124123 211.2535
0.9160302 205.0254 0.9160304 205.0254
0.9279389 197.0059 0.9279389 197.0059
0.9523525 191.1978 0.9523526 191.1978
0.9704132 186.4887 0.9704132 186.4887
0.9692958 185.5609 0.9692958 185.5609
0.9680378 184.6377 0.9680378 184.6377
0.9765168 184.6377 0.9765167 184.6377
0.9860514 182.8051 0.9860514 182.8051
0.9883636 182.8051 0.9883636 182.8051
0.9909548 181.8956 0.9909548 181.8956
0.991558 183.7191 0.991558 183.7191
0.9909708 185.5609 0.9909708 185.5609
0.9903754 187.4211 0.9903755 187.4211
0.9908676 189.3 0.9908676 189.3
0.9932029 191.1978 0.9932029 191.1978
0.9957952 191.1978 0.9957952 191.1978
0.9942913 191.1978 0.9942914 191.1978
0.9921361 189.3 0.9921359 189.3
0.9943052 187.4211 0.9943052 187.4211
0.9959483 186.4887 0.9959483 186.4887
0.995445 188.3582 0.995445 188.3582
0.9905357 190.2465 0.9905357 190.2465
0.9810764 189.3 0.9810765 189.3
0.9172173 189.3 0.9172173 189.3
0.8372062 189.3 0.8372061 189.3
0.7548154 189.3 0.7548154 189.3
0.7888815 189.3 0.7888815 189.3
0.7481033 187.4211 0.7481033 187.4211
0.5982309 181.8956 0.598231 181.8956
0.4594264 180.9906 0.4594265 180.9906
0.3907863 181.8956 0.3907863 181.8956
0.3352165 180.9906 0.3352165 180.9906
0.1176404 178.3027 0.1176405 178.3027
0.07078326 173.046 0.07078327 173.046
-0.04527155 169.6279 -0.04527154 169.6279
-0.1348021 168.784 -0.1348021 168.784
0.0446675 167.1087 0.04466751 167.1087
0.09953012 164.6269 0.09953013 164.6269
0.0682964 162.182 0.0682964 162.182
0.06978174 163.8079 0.06978174 163.8079
0.1322864 165.4501 0.1322864 165.4501
...@@ -552,9 +552,9 @@ BAC009S0768W0290 [ ...@@ -552,9 +552,9 @@ BAC009S0768W0290 [
0.4650808 179.1942 0.4650808 179.1942
0.5486825 180.9906 0.5486825 180.9906
0.4580497 182.8051 0.4580497 182.8051
0.4908406 184.6377 0.4908407 184.6377
0.4697384 186.4887 0.4697383 186.4887
0.3304502 188.3582 0.3304503 188.3582
0.3914385 190.2465 0.3914385 190.2465
0.6257187 192.1537 0.6257187 192.1537
0.3618582 195.0505 0.3618582 195.0505
...@@ -564,11 +564,11 @@ BAC009S0768W0290 [ ...@@ -564,11 +564,11 @@ BAC009S0768W0290 [
0.1373097 207.0808 0.1373097 207.0808
0.2010625 210.2025 0.2010625 210.2025
0.3670651 213.3714 0.3670651 213.3714
0.3145424 216.5879 0.3145425 216.5879
0.8130425 219.853 0.8130425 219.853
0.8798357 222.057 0.8798357 222.057
0.9403204 223.1673 0.9403205 223.1673
0.9729699 224.2832 0.97297 224.2832
0.9836287 223.1673 0.9836287 223.1673
0.9911686 222.057 0.9911686 222.057
0.9915301 220.9523 0.9915301 220.9523
...@@ -577,37 +577,37 @@ BAC009S0768W0290 [ ...@@ -577,37 +577,37 @@ BAC009S0768W0290 [
0.9930059 217.6709 0.9930059 217.6709
0.9904228 217.6709 0.9904228 217.6709
0.962741 213.3714 0.962741 213.3714
0.9670217 209.1568 0.9670218 209.1568
0.9779282 206.0505 0.9779282 206.0505
0.9113221 202.9904 0.9113222 202.9904
0.8637169 196.0257 0.863717 196.0257
0.7813085 193.1145 0.7813085 193.1145
0.7102375 197.0059 0.7102375 197.0059
0.6673802 201.9805 0.6673803 201.9805
0.7775867 202.9904 0.7775867 202.9904
0.8043375 204.0054 0.8043374 204.0054
0.7297218 200.9756 0.7297218 200.9756
0.5714095 197.0059 0.5714095 197.0059
0.5821127 194.0801 0.5821126 194.0801
0.7140544 193.1145 0.7140544 193.1145
0.7262679 194.0801 0.7262678 194.0801
0.7389846 195.0505 0.7389845 195.0505
0.7598057 196.0257 0.7598057 196.0257
0.7466297 197.9909 0.7466297 197.9909
0.6394933 199.9758 0.6394933 199.9758
0.6129577 201.9805 0.6129577 201.9805
0.672642 202.9904 0.672642 202.9904
0.715472 202.9904 0.715472 202.9904
0.7394826 202.9904 0.7394825 202.9904
0.5446302 202.9904 0.5446303 202.9904
0.7562882 202.9904 0.7562882 202.9904
0.7478679 202.9904 0.7478679 202.9904
0.3738182 201.9805 0.3738182 201.9805
0.7470278 200.9756 0.7470279 200.9756
0.7631993 199.9758 0.7631992 199.9758
0.4866135 198.9809 0.4866134 198.9809
0.6727687 197.9909 0.6727687 197.9909
0.6740196 197.0059 0.6740197 197.0059
0.5121869 196.0257 0.5121869 196.0257
0.5960711 195.0505 0.5960711 195.0505
0.4775652 194.0801 0.4775652 194.0801
...@@ -615,23 +615,23 @@ BAC009S0768W0290 [ ...@@ -615,23 +615,23 @@ BAC009S0768W0290 [
0.7569727 192.1537 0.7569727 192.1537
0.3645771 190.2465 0.3645771 190.2465
0.7480979 188.3582 0.7480979 188.3582
0.6694579 186.4887 0.669458 186.4887
0.06009803 184.6377 0.06009803 184.6377
-0.2068706 182.8051 -0.2068706 182.8051
0.2833839 180.9906 0.2833839 180.9906
0.6422815 179.1942 0.6422815 179.1942
0.3581113 177.4156 0.3581112 177.4156
0.2500266 175.6547 0.2500266 175.6547
0.3498747 173.9112 0.3498747 173.9112
0.5696031 172.185 0.569603 172.185
0.09735301 170.476 0.097353 170.476
0.3730714 168.784 0.3730714 168.784
-0.1027659 167.1087 -0.1027659 167.1087
-0.1343261 165.4501 -0.1343261 165.4501
-0.1674749 163.8079 -0.1674749 163.8079
-0.09346908 162.182 -0.09346908 162.182
0.02017645 160.5723 0.02017644 160.5723
0.01829197 158.9785 0.01829195 158.9785
0.2345988 157.4006 0.2345988 157.4006
0.254218 155.8383 0.254218 155.8383
0.4619125 154.2915 0.4619125 154.2915
...@@ -639,117 +639,117 @@ BAC009S0768W0290 [ ...@@ -639,117 +639,117 @@ BAC009S0768W0290 [
0.6047359 176.533 0.6047359 176.533
0.7835823 178.3027 0.7835823 178.3027
0.8670148 175.6547 0.8670148 175.6547
0.935979 173.9112 0.9359789 173.9112
0.9631585 175.6547 0.9631585 175.6547
0.9587291 176.533 0.9587292 176.533
0.9695756 176.533 0.9695755 176.533
0.9835572 179.1942 0.9835575 179.1942
0.9900097 179.1942 0.9900097 179.1942
0.9886937 180.0902 0.9886937 180.0902
0.9895495 180.9906 0.9895495 180.9906
0.9944302 183.7191 0.9944302 183.7191
0.9966993 183.7191 0.9966992 183.7191
0.9946688 186.4887 0.9946688 186.4887
0.992237 189.3 0.992237 189.3
0.991775 191.1978 0.9917749 191.1978
0.9863276 192.1537 0.9863276 192.1537
0.9785607 192.1537 0.9785607 192.1537
0.980638 190.2465 0.9806378 190.2465
0.9924863 189.3 0.9924863 189.3
0.99017 188.3582 0.99017 188.3582
0.9820646 187.4211 0.9820646 187.4211
0.9470521 188.3582 0.9470521 188.3582
0.821671 187.4211 0.8216711 187.4211
0.7153458 190.2465 0.7153458 190.2465
0.7442878 193.1145 0.7442878 193.1145
0.5942695 196.0257 0.5942695 196.0257
0.5665524 197.0059 0.5665525 197.0059
0.535006 195.0505 0.535006 195.0505
0.6266476 193.1145 0.6266476 193.1145
0.6059492 194.0801 0.6059493 194.0801
0.6425897 198.9809 0.6425897 198.9809
0.8118222 206.0505 0.8118222 206.0505
0.8551767 210.2025 0.8551767 210.2025
0.8889339 211.2535 0.8889339 211.2535
0.9478161 211.2535 0.947816 211.2535
0.9787854 209.1568 0.9787855 209.1568
0.988611 208.1162 0.988611 208.1162
0.9873208 207.0808 0.987321 207.0808
0.9843316 205.0254 0.9843316 205.0254
0.9737096 204.0054 0.9737096 204.0054
0.9765183 202.9904 0.9765185 202.9904
0.9856598 202.9904 0.9856598 202.9904
0.9898717 204.0054 0.9898718 204.0054
0.9886412 204.0054 0.9886413 204.0054
0.989678 202.9904 0.989678 202.9904
0.9851701 200.9756 0.9851701 200.9756
0.9817262 198.9809 0.9817263 198.9809
0.9766666 196.0257 0.9766667 196.0257
0.9717003 194.0801 0.9717003 194.0801
0.9652436 193.1145 0.9652438 193.1145
0.9332103 193.1145 0.9332103 193.1145
0.9138571 194.0801 0.9138572 194.0801
0.8846416 194.0801 0.8846416 194.0801
0.9482774 195.0505 0.9482771 195.0505
0.9305539 196.0257 0.9305538 196.0257
0.8390872 197.0059 0.8390872 197.0059
0.7701216 197.9909 0.7701216 197.9909
0.7264634 197.9909 0.7264634 197.9909
0.7708728 197.9909 0.7708728 197.9909
0.8309863 197.9909 0.8309863 197.9909
0.8339165 197.9909 0.8339165 197.9909
0.7231911 197.0059 0.723191 197.0059
0.7247626 196.0257 0.7247626 196.0257
0.6088191 195.0505 0.608819 195.0505
0.3213559 194.0801 0.3213559 194.0801
0.2234745 193.1145 0.2234745 193.1145
-0.02573975 191.1978 -0.02573975 191.1978
0.05725722 189.3 0.05725723 189.3
0.218053 187.4211 0.218053 187.4211
0.4777128 185.5609 0.4777128 185.5609
0.5337028 182.8051 0.5337029 182.8051
0.2318051 180.0902 0.2318052 180.0902
0.4889631 177.4156 0.4889631 177.4156
0.08109105 174.7808 0.08109105 174.7808
0.7427354 172.185 0.7427355 172.185
0.8433576 171.3284 0.8433576 171.3284
0.938632 170.476 0.938632 170.476
0.9607551 168.784 0.9607551 168.784
0.9642594 167.1087 0.9642593 167.1087
0.963613 166.2773 0.963613 166.2773
0.9651926 167.1087 0.9651926 167.1087
0.9591027 168.784 0.9591027 168.784
0.9754831 172.185 0.9754831 172.185
0.9820763 176.533 0.9820764 176.533
0.9875088 180.0902 0.9875088 180.0902
0.9851621 181.8956 0.9851621 181.8956
0.9825415 183.7191 0.9825414 183.7191
0.9723955 185.5609 0.9723955 185.5609
0.956726 187.4211 0.9567259 187.4211
0.8835074 189.3 0.8835074 189.3
0.8628154 192.1537 0.8628154 192.1537
0.9157981 195.0505 0.9157982 195.0505
0.5938084 198.9809 0.5938084 198.9809
0.6943321 209.1568 0.6943321 209.1568
0.7714629 212.3098 0.7714629 212.3098
0.8662375 211.2535 0.8662375 211.2535
0.8497281 205.0254 0.849728 205.0254
0.7945137 196.0257 0.7945137 196.0257
0.7933524 188.3582 0.7933522 188.3582
0.6368725 178.3027 0.6368725 178.3027
0.5897154 167.1087 0.5897154 167.1087
0.3229582 158.1876 0.3229582 158.1876
0.2969382 144.605 0.2969382 144.605
0.3351896 141.7487 0.3351896 141.7487
0.3844909 146.0546 0.384491 146.0546
0.04096959 151.2439 0.04096958 151.2439
0.1369363 172.185 0.1369363 172.185
0.3727793 180.9906 0.3727793 180.9906
0.4194036 183.7191 0.4194036 183.7191
0.4396896 185.5609 0.4396896 185.5609
0.5275242 185.5609 0.5275242 185.5609
0.2498598 186.4887 0.2498598 186.4887
0.05898203 190.2465 0.05898202 190.2465
0.04901373 195.0505 0.04901373 195.0505
0.1100158 197.9909 0.1100158 197.9909
0.2187118 198.9809 0.2187118 198.9809
...@@ -761,15 +761,15 @@ BAC009S0768W0290 [ ...@@ -761,15 +761,15 @@ BAC009S0768W0290 [
0.1344986 205.0254 0.1344986 205.0254
0.1769232 207.0808 0.1769232 207.0808
0.2019505 209.1568 0.2019505 209.1568
0.3217677 211.2535 0.3217678 211.2535
0.366561 213.3714 0.366561 213.3714
0.3891162 215.5104 0.3891162 215.5104
0.3456502 217.6709 0.3456501 217.6709
0.3461981 219.853 0.3461981 219.853
0.1349857 222.057 0.1349857 222.057
0.06558778 224.2832 0.06558777 224.2832
0.3975419 226.5316 0.397542 226.5316
0.6970221 228.8026 0.697022 228.8026
0.4396819 231.0963 0.4396819 231.0963
0.7819827 233.4131 0.7819827 233.4131
0.7121504 235.753 0.7121504 235.753
...@@ -781,66 +781,66 @@ BAC009S0768W0290 [ ...@@ -781,66 +781,66 @@ BAC009S0768W0290 [
0.6519101 249.0485 0.6519101 249.0485
0.5185443 251.5452 0.5185443 251.5452
0.9164662 254.067 0.9164662 254.067
0.9069664 255.3373 0.9069665 255.3373
0.9549389 254.067 0.9549389 254.067
0.9885622 252.8029 0.9885621 252.8029
0.9925307 251.5452 0.9925307 251.5452
0.9942389 249.0485 0.9942389 249.0485
0.996495 249.0485 0.996495 249.0485
0.9955549 247.8095 0.9955549 247.8095
0.9936098 246.5766 0.9936098 246.5766
0.9804759 245.3498 0.980476 245.3498
0.9671 246.5766 0.9671 246.5766
0.9642797 249.0485 0.9642795 249.0485
0.9722588 249.0485 0.9722587 249.0485
0.9746529 249.0485 0.974653 249.0485
0.9627596 247.8095 0.9627596 247.8095
0.9594576 247.8095 0.9594576 247.8095
0.9352374 247.8095 0.9352374 247.8095
0.9516878 246.5766 0.9516878 246.5766
0.9676834 245.3498 0.9676836 245.3498
0.9551129 246.5766 0.9551129 246.5766
0.9023392 249.0485 0.9023392 249.0485
0.8472682 251.5452 0.8472683 251.5452
0.8856258 254.067 0.8856258 254.067
0.888416 255.3373 0.8884159 255.3373
0.9254211 255.3373 0.9254211 255.3373
0.9612989 254.067 0.9612991 254.067
0.9673759 250.2938 0.9673759 250.2938
0.9728466 245.3498 0.9728466 245.3498
0.967782 242.9146 0.967782 242.9146
0.9654289 240.5036 0.9654288 240.5036
0.9444144 238.1164 0.9444144 238.1164
0.9269778 236.9318 0.9269778 236.9318
0.9488637 236.9318 0.9488637 236.9318
0.9771202 236.9318 0.9771202 236.9318
0.9830478 235.753 0.9830479 235.753
0.97499 234.5801 0.97499 234.5801
0.968623 233.4131 0.968623 233.4131
0.952177 233.4131 0.9521769 233.4131
0.9390221 233.4131 0.9390221 233.4131
0.9339336 233.4131 0.9339334 233.4131
0.887956 232.2518 0.887956 232.2518
0.9046763 231.0963 0.9046763 231.0963
0.8827982 229.9466 0.8827981 229.9466
0.8236388 231.0963 0.8236388 231.0963
0.7853005 231.0963 0.7853005 231.0963
0.8529193 229.9466 0.8529194 229.9466
0.8421693 227.6642 0.8421693 227.6642
0.8806722 224.2832 0.880672 224.2832
0.8143209 219.853 0.8143209 219.853
0.8765386 215.5104 0.8765387 215.5104
0.8224545 210.2025 0.8224545 210.2025
0.5476996 204.0054 0.5476995 204.0054
0.3984697 197.0059 0.3984698 197.0059
0.2524757 189.3 0.2524756 189.3
0.0114817 180.9906 0.0114817 180.9906
0.2040667 172.185 0.2040667 172.185
-0.1669366 163.8079 -0.1669366 163.8079
0.504205 154.2915 0.504205 154.2915
0.7180876 151.2439 0.7180874 151.2439
0.8632782 151.2439 0.8632782 151.2439
0.897326 150.4914 0.8973259 150.4914
0.9185986 151.2439 0.9185986 151.2439
0.7587776 154.2915 0.7587776 154.2915
0.7147576 159.7734 0.7147576 159.7734
...@@ -848,17 +848,17 @@ BAC009S0768W0290 [ ...@@ -848,17 +848,17 @@ BAC009S0768W0290 [
0.8840488 171.3284 0.8840488 171.3284
0.972356 175.6547 0.972356 175.6547
0.9816653 179.1942 0.9816653 179.1942
0.9884431 180.9906 0.988443 180.9906
0.9923041 181.8956 0.9923041 181.8956
0.9943824 182.8051 0.9943824 182.8051
0.9964478 183.7191 0.9964477 183.7191
0.9936554 181.8956 0.9936554 181.8956
0.9887792 180.0902 0.9887792 180.0902
0.9771132 175.6547 0.9771134 175.6547
0.961832 170.476 0.9618319 170.476
0.9328525 167.9442 0.9328524 167.9442
0.8199741 168.784 0.819974 168.784
0.8450116 170.476 0.8450117 170.476
0.8293109 171.3284 0.8293109 171.3284
0.6963592 171.3284 0.6963592 171.3284
0.6338254 164.6269 0.6338254 164.6269
...@@ -868,10 +868,10 @@ BAC009S0768W0290 [ ...@@ -868,10 +868,10 @@ BAC009S0768W0290 [
0.9278697 152.0001 0.9278697 152.0001
0.9533199 151.2439 0.9533199 151.2439
0.9601526 149.7427 0.9601526 149.7427
0.9562846 148.9977 0.9562845 148.9977
0.9630261 149.7427 0.963026 149.7427
0.9602929 149.7427 0.9602929 149.7427
0.8744307 150.4914 0.8744306 150.4914
0.5927675 154.2915 0.5927675 154.2915
0.3564559 159.7734 0.3564559 159.7734
0.2405773 164.6269 0.2405773 164.6269
...@@ -881,23 +881,23 @@ BAC009S0768W0290 [ ...@@ -881,23 +881,23 @@ BAC009S0768W0290 [
0.8849658 179.1942 0.8849658 179.1942
0.875807 180.9906 0.875807 180.9906
0.823069 182.8051 0.823069 182.8051
0.6626109 184.6377 0.6626108 184.6377
0.2836408 187.4211 0.2836408 187.4211
0.6051245 190.2465 0.6051244 190.2465
0.7253854 193.1145 0.7253854 193.1145
0.765985 196.0257 0.765985 196.0257
0.8194041 198.9809 0.8194041 198.9809
0.6263421 201.9805 0.6263421 201.9805
0.801713 205.0254 0.8017131 205.0254
0.682602 209.1568 0.682602 209.1568
0.5036187 213.3714 0.5036187 213.3714
0.5814967 218.7592 0.5814967 218.7592
0.814868 224.2832 0.814868 224.2832
0.8269848 229.9466 0.8269848 229.9466
0.7358219 235.753 0.7358219 235.753
0.4268065 241.7061 0.4268066 241.7061
0.8835183 247.8095 0.8835183 247.8095
0.8267586 254.067 0.8267587 254.067
0.5491355 259.1866 0.5491355 259.1866
0.8746379 264.4093 0.8746379 264.4093
0.8389229 269.7372 0.8389229 269.7372
...@@ -908,26 +908,26 @@ BAC009S0768W0290 [ ...@@ -908,26 +908,26 @@ BAC009S0768W0290 [
0.7583002 298.0316 0.7583002 298.0316
0.9073849 304.037 0.9073849 304.037
0.9051184 310.1635 0.9051184 310.1635
0.6434599 316.4135 0.64346 316.4135
0.9253378 322.7894 0.9253378 322.7894
0.9132794 329.2938 0.9132795 329.2938
0.6598361 334.2579 0.6598362 334.2579
0.9356085 339.2969 0.9356085 339.2969
0.9236956 344.4118 0.9236958 344.4118
0.8228285 349.6039 0.8228285 349.6039
0.9376769 354.8742 0.9376769 354.8742
0.9356694 360.224 0.9356694 360.224
0.9184376 365.6544 0.9184375 365.6544
0.9058462 371.1667 0.9058462 371.1667
0.9012623 374.8877 0.9012623 374.8877
0.9611986 378.6459 0.9611984 378.6459
0.956763 382.4419 0.9567629 382.4419
0.7675866 384.3541 0.7675866 384.3541
0.9645272 386.2758 0.9645271 386.2758
0.9546856 388.2072 0.9546855 388.2072
0.7844604 388.2072 0.7844603 388.2072
0.9640375 388.2072 0.9640375 388.2072
0.9452957 388.2072 0.9452955 388.2072
0.5753929 388.2072 0.5753929 388.2072
0.394645 388.2072 0.394645 388.2072
0.5464906 388.2072 0.5464906 388.2072
......
因为 它太大了无法显示 source diff 。你可以改为 查看blob
Markdown is supported
0% .
You are about to add 0 people to the discussion. Proceed with caution.
先完成此消息的编辑!
想要评论请 注册