diff options
Diffstat (limited to 'WebCore/platform/audio')
254 files changed, 392 insertions, 44 deletions
diff --git a/WebCore/platform/audio/AudioResampler.cpp b/WebCore/platform/audio/AudioResampler.cpp index 7f8221e..ba5b58e 100644 --- a/WebCore/platform/audio/AudioResampler.cpp +++ b/WebCore/platform/audio/AudioResampler.cpp @@ -30,7 +30,7 @@ #include "AudioBus.h" #include <algorithm> -#include <math.h> +#include <wtf/MathExtras.h> using namespace std; diff --git a/WebCore/platform/audio/AudioUtilities.cpp b/WebCore/platform/audio/AudioUtilities.cpp index 32f4335..7a4b32e 100644 --- a/WebCore/platform/audio/AudioUtilities.cpp +++ b/WebCore/platform/audio/AudioUtilities.cpp @@ -24,9 +24,10 @@ #include "config.h" -#include "AudioUtilities.h" +#if ENABLE(WEB_AUDIO) -#include <math.h> +#include "AudioUtilities.h" +#include <wtf/MathExtras.h> namespace WebCore { @@ -50,9 +51,13 @@ double linearToDecibels(double linear) double discreteTimeConstantForSampleRate(double timeConstant, double sampleRate) { - return 1.0 - pow(1.0 / M_E, 1.0 / (sampleRate * timeConstant)); + // hardcoded value is temporary build fix for Windows. + // FIXME: replace hardcode 2.718282 with M_E until the correct MathExtras.h solution is determined. + return 1.0 - pow(1.0 / 2.718282, 1.0 / (sampleRate * timeConstant)); } } // AudioUtilites } // WebCore + +#endif // ENABLE(WEB_AUDIO) diff --git a/WebCore/platform/audio/Biquad.cpp b/WebCore/platform/audio/Biquad.cpp index 49f010b..20143e3 100644 --- a/WebCore/platform/audio/Biquad.cpp +++ b/WebCore/platform/audio/Biquad.cpp @@ -33,9 +33,8 @@ #include "Biquad.h" #include <algorithm> -#include <float.h> -#include <math.h> #include <stdio.h> +#include <wtf/MathExtras.h> #if OS(DARWIN) #include <Accelerate/Accelerate.h> @@ -197,7 +196,7 @@ void Biquad::setLowpassParams(double cutoff, double resonance) double d = sqrt((4.0 - sqrt(16.0 - 16.0 / (g * g))) / 2.0); // Compute biquad coefficients for lopass filter - double theta = M_PI * cutoff; + double theta = piDouble * cutoff; double sn = 0.5 * d * sin(theta); double beta = 0.5 * (1.0 - sn) / (1.0 + sn); double gamma = (0.5 + beta) * cos(theta); @@ -218,7 +217,7 @@ void Biquad::setHighpassParams(double cutoff, double resonance) double d = sqrt((4.0 - sqrt(16.0 - 16.0 / (g * g))) / 2.0); // Compute biquad coefficients for highpass filter - double theta = M_PI * cutoff; + double theta = piDouble * cutoff; double sn = 0.5 * d * sin(theta); double beta = 0.5 * (1.0 - sn) / (1.0 + sn); double gamma = (0.5 + beta) * cos(theta); @@ -233,7 +232,7 @@ void Biquad::setHighpassParams(double cutoff, double resonance) void Biquad::setLowShelfParams(double cutoff, double dbGain) { - double theta = M_PI * cutoff; + double theta = piDouble * cutoff; double A = pow(10.0, dbGain / 40.0); double S = 1.0; // filter slope (1.0 is max value) diff --git a/WebCore/platform/audio/Cone.cpp b/WebCore/platform/audio/Cone.cpp index 91813ab..f514cde 100644 --- a/WebCore/platform/audio/Cone.cpp +++ b/WebCore/platform/audio/Cone.cpp @@ -31,6 +31,7 @@ #if ENABLE(WEB_AUDIO) #include "Cone.h" +#include <wtf/MathExtras.h> namespace WebCore { @@ -41,21 +42,21 @@ ConeEffect::ConeEffect() { } -double ConeEffect::gain(Vector3 sourcePosition, Vector3 sourceOrientation, Vector3 listenerPosition) +double ConeEffect::gain(FloatPoint3D sourcePosition, FloatPoint3D sourceOrientation, FloatPoint3D listenerPosition) { if (sourceOrientation.isZero() || ((m_innerAngle == 360.0) && (m_outerAngle == 360.0))) return 1.0; // no cone specified - unity gain // Normalized source-listener vector - Vector3 sourceToListener = listenerPosition - sourcePosition; + FloatPoint3D sourceToListener = listenerPosition - sourcePosition; sourceToListener.normalize(); - Vector3 normalizedSourceOrientation = sourceOrientation; + FloatPoint3D normalizedSourceOrientation = sourceOrientation; normalizedSourceOrientation.normalize(); // Angle between the source orientation vector and the source-listener vector - double dotProduct = dot(sourceToListener, normalizedSourceOrientation); - double angle = 180.0 * acos(dotProduct) / M_PI; + double dotProduct = sourceToListener.dot(normalizedSourceOrientation); + double angle = 180.0 * acos(dotProduct) / piDouble; double absAngle = fabs(angle); // Divide by 2.0 here since API is entire angle (not half-angle) diff --git a/WebCore/platform/audio/Cone.h b/WebCore/platform/audio/Cone.h index 9936f28..f566018 100644 --- a/WebCore/platform/audio/Cone.h +++ b/WebCore/platform/audio/Cone.h @@ -29,7 +29,7 @@ #ifndef Cone_h #define Cone_h -#include <wtf/Vector3.h> +#include "FloatPoint3D.h" namespace WebCore { @@ -40,7 +40,7 @@ public: ConeEffect(); // Returns scalar gain for the given source/listener positions/orientations - double gain(Vector3 sourcePosition, Vector3 sourceOrientation, Vector3 listenerPosition); + double gain(FloatPoint3D sourcePosition, FloatPoint3D sourceOrientation, FloatPoint3D listenerPosition); // Angles in degrees void setInnerAngle(double innerAngle) { m_innerAngle = innerAngle; } diff --git a/WebCore/platform/audio/EqualPowerPanner.cpp b/WebCore/platform/audio/EqualPowerPanner.cpp index 2e4e10f..002b7c6 100644 --- a/WebCore/platform/audio/EqualPowerPanner.cpp +++ b/WebCore/platform/audio/EqualPowerPanner.cpp @@ -30,7 +30,7 @@ #include "AudioBus.h" #include "AudioUtilities.h" -#include <math.h> +#include <wtf/MathExtras.h> // Use a 50ms smoothing / de-zippering time-constant. const double SmoothingTimeConstant = 0.050; @@ -76,7 +76,7 @@ void EqualPowerPanner::pan(double azimuth, double /*elevation*/, AudioBus* input else desiredPanPosition = (azimuth + 30.0) / 60.0; - double desiredGainL = 0.5 * cos(M_PI * desiredPanPosition) + 0.5; + double desiredGainL = 0.5 * cos(piDouble * desiredPanPosition) + 0.5; double desiredGainR = sqrt(1.0 - desiredGainL*desiredGainL); // Don't de-zipper on first render call. diff --git a/WebCore/platform/audio/FFTFrame.cpp b/WebCore/platform/audio/FFTFrame.cpp index 17292b6..d9979d9 100644 --- a/WebCore/platform/audio/FFTFrame.cpp +++ b/WebCore/platform/audio/FFTFrame.cpp @@ -134,32 +134,32 @@ void FFTFrame::interpolateFrequencyComponents(const FFTFrame& frame1, const FFTF lastPhase2 = phase2; // Unwrap phase deltas - if (deltaPhase1 > M_PI) - deltaPhase1 -= 2.0 * M_PI; - if (deltaPhase1 < -M_PI) - deltaPhase1 += 2.0 * M_PI; - if (deltaPhase2 > M_PI) - deltaPhase2 -= 2.0 * M_PI; - if (deltaPhase2 < -M_PI) - deltaPhase2 += 2.0 * M_PI; + if (deltaPhase1 > piDouble) + deltaPhase1 -= 2.0 * piDouble; + if (deltaPhase1 < -piDouble) + deltaPhase1 += 2.0 * piDouble; + if (deltaPhase2 > piDouble) + deltaPhase2 -= 2.0 * piDouble; + if (deltaPhase2 < -piDouble) + deltaPhase2 += 2.0 * piDouble; // Blend group-delays double deltaPhaseBlend; - if (deltaPhase1 - deltaPhase2 > M_PI) - deltaPhaseBlend = s1 * deltaPhase1 + s2 * (2.0 * M_PI + deltaPhase2); - else if (deltaPhase2 - deltaPhase1 > M_PI) - deltaPhaseBlend = s1 * (2.0 * M_PI + deltaPhase1) + s2 * deltaPhase2; + if (deltaPhase1 - deltaPhase2 > piDouble) + deltaPhaseBlend = s1 * deltaPhase1 + s2 * (2.0 * piDouble + deltaPhase2); + else if (deltaPhase2 - deltaPhase1 > piDouble) + deltaPhaseBlend = s1 * (2.0 * piDouble + deltaPhase1) + s2 * deltaPhase2; else deltaPhaseBlend = s1 * deltaPhase1 + s2 * deltaPhase2; phaseAccum += deltaPhaseBlend; // Unwrap - if (phaseAccum > M_PI) - phaseAccum -= 2.0 * M_PI; - if (phaseAccum < -M_PI) - phaseAccum += 2.0 * M_PI; + if (phaseAccum > piDouble) + phaseAccum -= 2.0 * piDouble; + if (phaseAccum < -piDouble) + phaseAccum += 2.0 * piDouble; Complex c = complexFromMagnitudePhase(mag, phaseAccum); @@ -179,7 +179,7 @@ double FFTFrame::extractAverageGroupDelay() int halfSize = fftSize() / 2; - const double kSamplePhaseDelay = (2.0 * M_PI) / double(fftSize()); + const double kSamplePhaseDelay = (2.0 * piDouble) / double(fftSize()); // Calculate weighted average group delay for (int i = 0; i < halfSize; i++) { @@ -191,10 +191,10 @@ double FFTFrame::extractAverageGroupDelay() lastPhase = phase; // Unwrap - if (deltaPhase < -M_PI) - deltaPhase += 2.0 * M_PI; - if (deltaPhase > M_PI) - deltaPhase -= 2.0 * M_PI; + if (deltaPhase < -piDouble) + deltaPhase += 2.0 * piDouble; + if (deltaPhase > piDouble) + deltaPhase -= 2.0 * piDouble; aveSum += mag * deltaPhase; weightSum += mag; @@ -224,7 +224,7 @@ void FFTFrame::addConstantGroupDelay(double sampleFrameDelay) float* realP = realData(); float* imagP = imagData(); - const double kSamplePhaseDelay = (2.0 * M_PI) / double(fftSize()); + const double kSamplePhaseDelay = (2.0 * piDouble) / double(fftSize()); double phaseAdj = -sampleFrameDelay * kSamplePhaseDelay; diff --git a/WebCore/platform/audio/FFTFrame.h b/WebCore/platform/audio/FFTFrame.h index 6147fc1..1a82ef0 100644 --- a/WebCore/platform/audio/FFTFrame.h +++ b/WebCore/platform/audio/FFTFrame.h @@ -35,6 +35,10 @@ #include <Accelerate/Accelerate.h> #endif +#if !OS(DARWIN) && USE(WEBAUDIO_MKL) +#include "mkl_dfti.h" +#endif + #include <wtf/PassOwnPtr.h> #include <wtf/Platform.h> @@ -95,6 +99,23 @@ private: AudioFloatArray m_realData; AudioFloatArray m_imagData; #endif // OS(DARWIN) +#if !OS(DARWIN) && USE(WEBAUDIO_MKL) + // Interleaves the planar real and imaginary data and returns a + // pointer to the resulting storage which can be used for in-place + // or out-of-place operations. FIXME: ideally all of the MKL + // routines would operate on planar data and this method would be + // removed. + float* getUpToDateComplexData(); + + static DFTI_DESCRIPTOR_HANDLE descriptorHandleForSize(unsigned fftSize); + + static DFTI_DESCRIPTOR_HANDLE* descriptorHandles; + + DFTI_DESCRIPTOR_HANDLE m_handle; + AudioFloatArray m_complexData; + AudioFloatArray m_realData; + AudioFloatArray m_imagData; +#endif // !OS(DARWIN) && USE(WEBAUDIO_MKL) }; } // namespace WebCore diff --git a/WebCore/platform/audio/HRTFElevation.cpp b/WebCore/platform/audio/HRTFElevation.cpp index ab722cd..06d03ea 100644 --- a/WebCore/platform/audio/HRTFElevation.cpp +++ b/WebCore/platform/audio/HRTFElevation.cpp @@ -34,7 +34,6 @@ #include "AudioBus.h" #include "AudioFileReader.h" -#include "AudioResources.h" #include "Biquad.h" #include "FFTFrame.h" #include "HRTFPanner.h" @@ -108,9 +107,10 @@ bool HRTFElevation::calculateKernelsForAzimuthElevation(int azimuth, int elevati return false; size_t responseLength = impulseResponse->length(); + size_t expectedLength = static_cast<size_t>(256 * (sampleRate / 44100.0)); // Check number of channels and length. For now these are fixed and known. - bool isBusGood = responseLength == 512 && impulseResponse->numberOfChannels() == 2; + bool isBusGood = responseLength == expectedLength && impulseResponse->numberOfChannels() == 2; ASSERT(isBusGood); if (!isBusGood) return false; diff --git a/WebCore/platform/audio/HRTFKernel.cpp b/WebCore/platform/audio/HRTFKernel.cpp index 852cdbf..22d4b12 100644 --- a/WebCore/platform/audio/HRTFKernel.cpp +++ b/WebCore/platform/audio/HRTFKernel.cpp @@ -35,6 +35,7 @@ #include "AudioChannel.h" #include "Biquad.h" #include "FFTFrame.h" +#include <wtf/MathExtras.h> using namespace std; diff --git a/WebCore/platform/audio/HRTFPanner.cpp b/WebCore/platform/audio/HRTFPanner.cpp index 56f06f1..68bc505 100644 --- a/WebCore/platform/audio/HRTFPanner.cpp +++ b/WebCore/platform/audio/HRTFPanner.cpp @@ -33,7 +33,7 @@ #include "HRTFDatabase.h" #include "HRTFDatabaseLoader.h" #include <algorithm> -#include <math.h> +#include <wtf/MathExtras.h> #include <wtf/RefPtr.h> using namespace std; diff --git a/WebCore/platform/audio/chromium/AudioBusChromium.cpp b/WebCore/platform/audio/chromium/AudioBusChromium.cpp new file mode 100644 index 0000000..a93703d --- /dev/null +++ b/WebCore/platform/audio/chromium/AudioBusChromium.cpp @@ -0,0 +1,61 @@ +/* + * Copyright (C) 2010, Google Inc. All rights reserved. + * + * Redistribution and use in source and binary forms, with or without + * modification, are permitted provided that the following conditions + * are met: + * 1. Redistributions of source code must retain the above copyright + * notice, this list of conditions and the following disclaimer. + * 2. Redistributions in binary form must reproduce the above copyright + * notice, this list of conditions and the following disclaimer in the + * documentation and/or other materials provided with the distribution. + * + * THIS SOFTWARE IS PROVIDED BY APPLE INC. AND ITS CONTRIBUTORS ``AS IS'' AND ANY + * EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED + * WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE + * DISCLAIMED. IN NO EVENT SHALL APPLE INC. OR ITS CONTRIBUTORS BE LIABLE FOR ANY + * DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES + * (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; + * LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON + * ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT + * (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS + * SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. + */ + +#include "config.h" + +#if ENABLE(WEB_AUDIO) + +#include "AudioBus.h" + +#include "AudioFileReader.h" +#include "ChromiumBridge.h" +#include <wtf/PassOwnPtr.h> + +namespace WebCore { + +// We will use this version of loadPlatformResource() once the resources are checked into Chromium. + +// PassOwnPtr<AudioBus> AudioBus::loadPlatformResource(const char* name, double sampleRate) +// { +// return ChromiumBridge::loadPlatformAudioResource(name, sampleRate); +// } + +PassOwnPtr<AudioBus> createBusFromInMemoryAudioFile(const void* data, size_t dataSize, bool mixToMono, double sampleRate) +{ + OwnPtr<AudioBus> audioBus = ChromiumBridge::decodeAudioFileData(static_cast<const char*>(data), dataSize, sampleRate); + if (audioBus->numberOfChannels() == 2 && mixToMono) { + OwnPtr<AudioBus> monoAudioBus = adoptPtr(new AudioBus(1, audioBus->length())); + + // FIXME: AudioBus::copyFrom() should be able to do a downmix to mono. + // for now simply copy the left channel. + monoAudioBus->channel(0)->copyFrom(audioBus->channel(0)); + return monoAudioBus.release(); + } + + return audioBus.release(); +} + +} // namespace WebCore + +#endif // ENABLE(WEB_AUDIO) diff --git a/WebCore/platform/audio/mac/AudioBusMac.mm b/WebCore/platform/audio/mac/AudioBusMac.mm index 3f3185a..3d454a9 100644 --- a/WebCore/platform/audio/mac/AudioBusMac.mm +++ b/WebCore/platform/audio/mac/AudioBusMac.mm @@ -47,7 +47,7 @@ PassOwnPtr<AudioBus> AudioBus::loadPlatformResource(const char* name, double sam NSAutoreleasePool* pool = [[NSAutoreleasePool alloc] init]; NSBundle *bundle = [NSBundle bundleForClass:[WebCoreAudioBundleClass class]]; - NSString *audioFilePath = [bundle pathForResource:[NSString stringWithUTF8String:name] ofType:@"aif" inDirectory:@"audio"]; + NSString *audioFilePath = [bundle pathForResource:[NSString stringWithUTF8String:name] ofType:@"wav" inDirectory:@"audio"]; NSData *audioData = [NSData dataWithContentsOfFile:audioFilePath]; if (audioData) { diff --git a/WebCore/platform/audio/mkl/FFTFrameMKL.cpp b/WebCore/platform/audio/mkl/FFTFrameMKL.cpp new file mode 100644 index 0000000..f66a485 --- /dev/null +++ b/WebCore/platform/audio/mkl/FFTFrameMKL.cpp @@ -0,0 +1,260 @@ +/* + * Copyright (C) 2010 Google Inc. All rights reserved. + * + * Redistribution and use in source and binary forms, with or without + * modification, are permitted provided that the following conditions + * are met: + * + * 1. Redistributions of source code must retain the above copyright + * notice, this list of conditions and the following disclaimer. + * 2. Redistributions in binary form must reproduce the above copyright + * notice, this list of conditions and the following disclaimer in the + * documentation and/or other materials provided with the distribution. + * + * THIS SOFTWARE IS PROVIDED BY APPLE AND ITS CONTRIBUTORS "AS IS" AND ANY + * EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED + * WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE + * DISCLAIMED. IN NO EVENT SHALL APPLE OR ITS CONTRIBUTORS BE LIABLE FOR ANY + * DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES + * (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; + * LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND + * ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT + * (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF + * THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. + */ + +// FFTFrame implementation using Intel's Math Kernel Library (MKL), +// suitable for use on Windows and Linux. + +#include "config.h" + +#if ENABLE(WEB_AUDIO) + +#include "FFTFrame.h" + +#include "mkl_vml.h" +#include <wtf/MathExtras.h> + +namespace { + +DFTI_DESCRIPTOR_HANDLE createDescriptorHandle(int fftSize) +{ + DFTI_DESCRIPTOR_HANDLE handle = 0; + + // Create DFTI descriptor for 1D single precision transform. + MKL_LONG status = DftiCreateDescriptor(&handle, DFTI_SINGLE, DFTI_REAL, 1, fftSize); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + // Set placement of result to DFTI_NOT_INPLACE. + status = DftiSetValue(handle, DFTI_PLACEMENT, DFTI_NOT_INPLACE); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + // Set packing format to PERM; this produces the layout which + // matches Accelerate.framework's on the Mac, though interleaved. + status = DftiSetValue(handle, DFTI_PACKED_FORMAT, DFTI_PERM_FORMAT); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + // Set the forward scale factor to 2 to match Accelerate.framework's. + // FIXME: FFTFrameMac's scaling factor could be fixed to be 1.0, + // in which case this code would need to be changed as well. + status = DftiSetValue(handle, DFTI_FORWARD_SCALE, 2.0); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + // Set the backward scale factor to 1 / 2n to match Accelerate.framework's. + // FIXME: if the above scaling factor is fixed then this needs to be as well. + double scale = 1.0 / (2.0 * fftSize); + status = DftiSetValue(handle, DFTI_BACKWARD_SCALE, scale); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + // Use the default DFTI_CONJUGATE_EVEN_STORAGE = DFTI_COMPLEX_REAL. + + // Commit DFTI descriptor. + status = DftiCommitDescriptor(handle); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + return handle; +} + +} // anonymous namespace + +namespace WebCore { + +const int kMaxFFTPow2Size = 24; + +DFTI_DESCRIPTOR_HANDLE* FFTFrame::descriptorHandles = 0; + +// Normal constructor: allocates for a given fftSize. +FFTFrame::FFTFrame(unsigned fftSize) + : m_FFTSize(fftSize) + , m_log2FFTSize(static_cast<unsigned>(log2(fftSize))) + , m_handle(0) + , m_complexData(fftSize) + , m_realData(fftSize / 2) + , m_imagData(fftSize / 2) +{ + // We only allow power of two. + ASSERT(1UL << m_log2FFTSize == m_FFTSize); + + m_handle = descriptorHandleForSize(fftSize); +} + +// Creates a blank/empty frame (interpolate() must later be called). +FFTFrame::FFTFrame() + : m_FFTSize(0) + , m_log2FFTSize(0) + , m_handle(0) +{ +} + +// Copy constructor. +FFTFrame::FFTFrame(const FFTFrame& frame) + : m_FFTSize(frame.m_FFTSize) + , m_log2FFTSize(frame.m_log2FFTSize) + , m_handle(0) + , m_complexData(frame.m_FFTSize) + , m_realData(frame.m_FFTSize / 2) + , m_imagData(frame.m_FFTSize / 2) +{ + m_handle = descriptorHandleForSize(m_FFTSize); + + // Copy/setup frame data. + unsigned nbytes = sizeof(float) * (m_FFTSize / 2); + memcpy(realData(), frame.realData(), nbytes); + memcpy(imagData(), frame.imagData(), nbytes); +} + +FFTFrame::~FFTFrame() +{ +} + +void FFTFrame::multiply(const FFTFrame& frame) +{ + FFTFrame& frame1 = *this; + FFTFrame& frame2 = const_cast<FFTFrame&>(frame); + + float* realP1 = frame1.realData(); + float* imagP1 = frame1.imagData(); + const float* realP2 = frame2.realData(); + const float* imagP2 = frame2.imagData(); + + // Scale accounts for vecLib's peculiar scaling. + // This ensures the right scaling all the way back to inverse FFT. + // FIXME: this scaling factor will be 1.0f if the above 2.0 -> 1.0 + // scaling factor is fixed. + float scale = 0.5f; + + // Multiply packed DC/nyquist component. + realP1[0] *= scale * realP2[0]; + imagP1[0] *= scale * imagP2[0]; + + // Multiply the rest, skipping packed DC/Nyquist components. + float* interleavedData1 = frame1.getUpToDateComplexData(); + float* interleavedData2 = frame2.getUpToDateComplexData(); + + unsigned halfSize = m_FFTSize / 2; + + // Complex multiply. + vcMul(halfSize - 1, + reinterpret_cast<MKL_Complex8*>(interleavedData1) + 1, + reinterpret_cast<MKL_Complex8*>(interleavedData2) + 1, + reinterpret_cast<MKL_Complex8*>(interleavedData1) + 1); + + // De-interleave and scale the rest of the data. + // FIXME: find an MKL routine to do at least the scaling more efficiently. + for (unsigned i = 1; i < halfSize; ++i) { + int baseComplexIndex = 2 * i; + realP1[i] = scale * interleavedData1[baseComplexIndex]; + imagP1[i] = scale * interleavedData1[baseComplexIndex + 1]; + } +} + +void FFTFrame::doFFT(float* data) +{ + // Compute Forward transform. + MKL_LONG status = DftiComputeForward(m_handle, data, m_complexData.data()); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + + // De-interleave to separate real and complex arrays. FIXME: + // figure out if it's possible to get MKL to use split-complex + // form for 1D real-to-complex out-of-place FFTs. + int len = m_FFTSize / 2; + for (int i = 0; i < len; ++i) { + int baseComplexIndex = 2 * i; + // m_realData[0] is the DC component and m_imagData[0] the + // Nyquist component since the interleaved complex data is + // packed. + m_realData[i] = m_complexData[baseComplexIndex]; + m_imagData[i] = m_complexData[baseComplexIndex + 1]; + } +} + +void FFTFrame::doInverseFFT(float* data) +{ + // Prepare interleaved data. FIXME: figure out if it's possible to + // get MKL to use split-complex form for 1D backward + // (complex-to-real) out-of-place FFTs. + float* interleavedData = getUpToDateComplexData(); + + // Compute backward transform. + MKL_LONG status = DftiComputeBackward(m_handle, interleavedData, data); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); +} + +void FFTFrame::cleanup() +{ + if (!descriptorHandles) + return; + + for (int i = 0; i < kMaxFFTPow2Size; ++i) { + if (descriptorHandles[i]) { + MKL_LONG status = DftiFreeDescriptor(&descriptorHandles[i]); + ASSERT(DftiErrorClass(status, DFTI_NO_ERROR)); + } + } + + delete[] descriptorHandles; + descriptorHandles = 0; +} + +float* FFTFrame::realData() const +{ + return const_cast<float*>(m_realData.data()); +} + +float* FFTFrame::imagData() const +{ + return const_cast<float*>(m_imagData.data()); +} + +float* FFTFrame::getUpToDateComplexData() +{ + // FIXME: if we can't completely get rid of this method, SSE + // optimization could be considered if it shows up hot on profiles. + int len = m_FFTSize / 2; + for (int i = 0; i < len; ++i) { + int baseComplexIndex = 2 * i; + m_complexData[baseComplexIndex] = m_realData[i]; + m_complexData[baseComplexIndex + 1] = m_imagData[i]; + } + return const_cast<float*>(m_complexData.data()); +} + +DFTI_DESCRIPTOR_HANDLE FFTFrame::descriptorHandleForSize(unsigned fftSize) +{ + if (!descriptorHandles) { + descriptorHandles = new DFTI_DESCRIPTOR_HANDLE[kMaxFFTPow2Size]; + for (int i = 0; i < kMaxFFTPow2Size; ++i) + descriptorHandles[i] = 0; + } + + ASSERT(fftSize); + int pow2size = static_cast<int>(log2(fftSize)); + ASSERT(pow2size < kMaxFFTPow2Size); + if (!descriptorHandles[pow2size]) + descriptorHandles[pow2size] = createDescriptorHandle(fftSize); + return descriptorHandles[pow2size]; +} + +} // namespace WebCore + +#endif // ENABLE(WEB_AUDIO) diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P000.wav Binary files differnew file mode 100644 index 0000000..57f2ef3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P015.wav Binary files differnew file mode 100644 index 0000000..3ecea33 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P030.wav Binary files differnew file mode 100644 index 0000000..7320802 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P045.wav Binary files differnew file mode 100644 index 0000000..1a10d9a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P060.wav Binary files differnew file mode 100644 index 0000000..9b12c22 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P075.wav Binary files differnew file mode 100644 index 0000000..3153bb8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P090.wav Binary files differnew file mode 100644 index 0000000..3282da9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P315.wav Binary files differnew file mode 100644 index 0000000..b999852 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P330.wav Binary files differnew file mode 100644 index 0000000..53a03b6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P345.wav Binary files differnew file mode 100644 index 0000000..16d5766 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T000_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P000.wav Binary files differnew file mode 100644 index 0000000..3788e16 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P015.wav Binary files differnew file mode 100644 index 0000000..ad2efb6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P030.wav Binary files differnew file mode 100644 index 0000000..ee86702 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P045.wav Binary files differnew file mode 100644 index 0000000..98ff82e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P060.wav Binary files differnew file mode 100644 index 0000000..98ff82e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P075.wav Binary files differnew file mode 100644 index 0000000..98ff82e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P090.wav Binary files differnew file mode 100644 index 0000000..98ff82e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P315.wav Binary files differnew file mode 100644 index 0000000..10bdf78 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P330.wav Binary files differnew file mode 100644 index 0000000..c8398a4 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P345.wav Binary files differnew file mode 100644 index 0000000..82b92a8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T015_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P000.wav Binary files differnew file mode 100644 index 0000000..8b8714c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P015.wav Binary files differnew file mode 100644 index 0000000..882efd4 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P030.wav Binary files differnew file mode 100644 index 0000000..abd99e6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P045.wav Binary files differnew file mode 100644 index 0000000..28765be --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P060.wav Binary files differnew file mode 100644 index 0000000..42c1445 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P075.wav Binary files differnew file mode 100644 index 0000000..42c1445 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P090.wav Binary files differnew file mode 100644 index 0000000..42c1445 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P315.wav Binary files differnew file mode 100644 index 0000000..99b00f7 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P330.wav Binary files differnew file mode 100644 index 0000000..f81bee2 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P345.wav Binary files differnew file mode 100644 index 0000000..139d0cb --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T030_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P000.wav Binary files differnew file mode 100644 index 0000000..68b7b4f --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P015.wav Binary files differnew file mode 100644 index 0000000..d6773ae --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P030.wav Binary files differnew file mode 100644 index 0000000..9e786bb --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P045.wav Binary files differnew file mode 100644 index 0000000..fbef2f3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P060.wav Binary files differnew file mode 100644 index 0000000..fbef2f3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P075.wav Binary files differnew file mode 100644 index 0000000..fbef2f3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P090.wav Binary files differnew file mode 100644 index 0000000..fbef2f3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P315.wav Binary files differnew file mode 100644 index 0000000..3c53b76 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P330.wav Binary files differnew file mode 100644 index 0000000..e4524c0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P345.wav Binary files differnew file mode 100644 index 0000000..ff12535 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T045_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P000.wav Binary files differnew file mode 100644 index 0000000..5bb1b17 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P015.wav Binary files differnew file mode 100644 index 0000000..47e0209 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P030.wav Binary files differnew file mode 100644 index 0000000..536b4ac --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P045.wav Binary files differnew file mode 100644 index 0000000..05152ad --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P060.wav Binary files differnew file mode 100644 index 0000000..221637b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P075.wav Binary files differnew file mode 100644 index 0000000..7d6d07f --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P090.wav Binary files differnew file mode 100644 index 0000000..7d6d07f --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P315.wav Binary files differnew file mode 100644 index 0000000..a4eca78 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P330.wav Binary files differnew file mode 100644 index 0000000..37393c2 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P345.wav Binary files differnew file mode 100644 index 0000000..3d56e26 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T060_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P000.wav Binary files differnew file mode 100644 index 0000000..2159f3d --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P015.wav Binary files differnew file mode 100644 index 0000000..8b689f6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P030.wav Binary files differnew file mode 100644 index 0000000..9ee8ac5 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P045.wav Binary files differnew file mode 100644 index 0000000..88124e9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P060.wav Binary files differnew file mode 100644 index 0000000..88124e9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P075.wav Binary files differnew file mode 100644 index 0000000..88124e9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P090.wav Binary files differnew file mode 100644 index 0000000..88124e9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P315.wav Binary files differnew file mode 100644 index 0000000..59441a6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P330.wav Binary files differnew file mode 100644 index 0000000..7cac0f5 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P345.wav Binary files differnew file mode 100644 index 0000000..dc28d64 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T075_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P000.wav Binary files differnew file mode 100644 index 0000000..ae7e583 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P015.wav Binary files differnew file mode 100644 index 0000000..509449e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P030.wav Binary files differnew file mode 100644 index 0000000..e23b20c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P045.wav Binary files differnew file mode 100644 index 0000000..cf247b9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P060.wav Binary files differnew file mode 100644 index 0000000..f49d520 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P075.wav Binary files differnew file mode 100644 index 0000000..f49d520 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P090.wav Binary files differnew file mode 100644 index 0000000..f49d520 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P315.wav Binary files differnew file mode 100644 index 0000000..e5472f1 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P330.wav Binary files differnew file mode 100644 index 0000000..8e1af83 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P345.wav Binary files differnew file mode 100644 index 0000000..c477193 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T090_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P000.wav Binary files differnew file mode 100644 index 0000000..4236e08 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P015.wav Binary files differnew file mode 100644 index 0000000..2461fb0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P030.wav Binary files differnew file mode 100644 index 0000000..11d549b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P045.wav Binary files differnew file mode 100644 index 0000000..0aa100e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P060.wav Binary files differnew file mode 100644 index 0000000..0aa100e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P075.wav Binary files differnew file mode 100644 index 0000000..0aa100e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P090.wav Binary files differnew file mode 100644 index 0000000..0aa100e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P315.wav Binary files differnew file mode 100644 index 0000000..572e602 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P330.wav Binary files differnew file mode 100644 index 0000000..7f41da3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P345.wav Binary files differnew file mode 100644 index 0000000..d0101b8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T105_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P000.wav Binary files differnew file mode 100644 index 0000000..800fbd7 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P015.wav Binary files differnew file mode 100644 index 0000000..9b35e72 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P030.wav Binary files differnew file mode 100644 index 0000000..bb58c4e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P045.wav Binary files differnew file mode 100644 index 0000000..8963e3e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P060.wav Binary files differnew file mode 100644 index 0000000..22241ee --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P075.wav Binary files differnew file mode 100644 index 0000000..9e4fee0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P090.wav Binary files differnew file mode 100644 index 0000000..9e4fee0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P315.wav Binary files differnew file mode 100644 index 0000000..95976c6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P330.wav Binary files differnew file mode 100644 index 0000000..8fc55f1 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P345.wav Binary files differnew file mode 100644 index 0000000..eeeb702 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T120_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P000.wav Binary files differnew file mode 100644 index 0000000..1847d8d --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P015.wav Binary files differnew file mode 100644 index 0000000..52e812c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P030.wav Binary files differnew file mode 100644 index 0000000..32ca344 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P045.wav Binary files differnew file mode 100644 index 0000000..3de60c8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P060.wav Binary files differnew file mode 100644 index 0000000..3de60c8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P075.wav Binary files differnew file mode 100644 index 0000000..3de60c8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P090.wav Binary files differnew file mode 100644 index 0000000..3de60c8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P315.wav Binary files differnew file mode 100644 index 0000000..2668e41 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P330.wav Binary files differnew file mode 100644 index 0000000..e69670b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P345.wav Binary files differnew file mode 100644 index 0000000..1cc48ee --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T135_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P000.wav Binary files differnew file mode 100644 index 0000000..252968b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P015.wav Binary files differnew file mode 100644 index 0000000..50aff3c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P030.wav Binary files differnew file mode 100644 index 0000000..3abd6e8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P045.wav Binary files differnew file mode 100644 index 0000000..3f0d5ef --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P060.wav Binary files differnew file mode 100644 index 0000000..616f760 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P075.wav Binary files differnew file mode 100644 index 0000000..616f760 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P090.wav Binary files differnew file mode 100644 index 0000000..616f760 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P315.wav Binary files differnew file mode 100644 index 0000000..bfb6032 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P330.wav Binary files differnew file mode 100644 index 0000000..1983cdb --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P345.wav Binary files differnew file mode 100644 index 0000000..27c0762 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T150_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P000.wav Binary files differnew file mode 100644 index 0000000..b04391b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P015.wav Binary files differnew file mode 100644 index 0000000..5955612 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P030.wav Binary files differnew file mode 100644 index 0000000..af5d83a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P045.wav Binary files differnew file mode 100644 index 0000000..a592f71 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P060.wav Binary files differnew file mode 100644 index 0000000..a592f71 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P075.wav Binary files differnew file mode 100644 index 0000000..a592f71 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P090.wav Binary files differnew file mode 100644 index 0000000..a592f71 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P315.wav Binary files differnew file mode 100644 index 0000000..a985aa1 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P330.wav Binary files differnew file mode 100644 index 0000000..a8b83d1 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P345.wav Binary files differnew file mode 100644 index 0000000..7e649a3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T165_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P000.wav Binary files differnew file mode 100644 index 0000000..b74985c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P015.wav Binary files differnew file mode 100644 index 0000000..e112ee0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P030.wav Binary files differnew file mode 100644 index 0000000..ac842cc --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P045.wav Binary files differnew file mode 100644 index 0000000..95c3a6d --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P060.wav Binary files differnew file mode 100644 index 0000000..610eedb --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P075.wav Binary files differnew file mode 100644 index 0000000..d4a57bf --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P090.wav Binary files differnew file mode 100644 index 0000000..d4a57bf --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P315.wav Binary files differnew file mode 100644 index 0000000..bd6e4f8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P330.wav Binary files differnew file mode 100644 index 0000000..7d4be6f --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P345.wav Binary files differnew file mode 100644 index 0000000..b7ef81a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T180_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P000.wav Binary files differnew file mode 100644 index 0000000..0c4af2a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P015.wav Binary files differnew file mode 100644 index 0000000..dd7a505 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P030.wav Binary files differnew file mode 100644 index 0000000..e169049 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P045.wav Binary files differnew file mode 100644 index 0000000..49008a0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P060.wav Binary files differnew file mode 100644 index 0000000..49008a0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P075.wav Binary files differnew file mode 100644 index 0000000..49008a0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P090.wav Binary files differnew file mode 100644 index 0000000..49008a0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P315.wav Binary files differnew file mode 100644 index 0000000..1e7d478 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P330.wav Binary files differnew file mode 100644 index 0000000..2a77d74 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P345.wav Binary files differnew file mode 100644 index 0000000..843b928 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T195_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P000.wav Binary files differnew file mode 100644 index 0000000..770af17 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P015.wav Binary files differnew file mode 100644 index 0000000..437a1c6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P030.wav Binary files differnew file mode 100644 index 0000000..f0d9d8e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P045.wav Binary files differnew file mode 100644 index 0000000..cd4ae55 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P060.wav Binary files differnew file mode 100644 index 0000000..7dd5a1a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P075.wav Binary files differnew file mode 100644 index 0000000..7dd5a1a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P090.wav Binary files differnew file mode 100644 index 0000000..7dd5a1a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P315.wav Binary files differnew file mode 100644 index 0000000..bfac19d --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P330.wav Binary files differnew file mode 100644 index 0000000..8b3e086 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P345.wav Binary files differnew file mode 100644 index 0000000..8b4da46 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T210_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P000.wav Binary files differnew file mode 100644 index 0000000..b6d4703 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P015.wav Binary files differnew file mode 100644 index 0000000..0ff35e9 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P030.wav Binary files differnew file mode 100644 index 0000000..e934c78 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P045.wav Binary files differnew file mode 100644 index 0000000..c931e3c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P060.wav Binary files differnew file mode 100644 index 0000000..c931e3c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P075.wav Binary files differnew file mode 100644 index 0000000..c931e3c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P090.wav Binary files differnew file mode 100644 index 0000000..c931e3c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P315.wav Binary files differnew file mode 100644 index 0000000..f999966 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P330.wav Binary files differnew file mode 100644 index 0000000..d958590 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P345.wav Binary files differnew file mode 100644 index 0000000..ac06260 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T225_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P000.wav Binary files differnew file mode 100644 index 0000000..b720ed1 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P015.wav Binary files differnew file mode 100644 index 0000000..b48852a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P030.wav Binary files differnew file mode 100644 index 0000000..92c7ef0 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P045.wav Binary files differnew file mode 100644 index 0000000..2d5ff65 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P060.wav Binary files differnew file mode 100644 index 0000000..07dcfde --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P075.wav Binary files differnew file mode 100644 index 0000000..283e250 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P090.wav Binary files differnew file mode 100644 index 0000000..283e250 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P315.wav Binary files differnew file mode 100644 index 0000000..b99ad7d --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P330.wav Binary files differnew file mode 100644 index 0000000..4886915 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P345.wav Binary files differnew file mode 100644 index 0000000..c932833 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T240_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P000.wav Binary files differnew file mode 100644 index 0000000..b204def --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P015.wav Binary files differnew file mode 100644 index 0000000..fa48113 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P030.wav Binary files differnew file mode 100644 index 0000000..2e2de70 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P045.wav Binary files differnew file mode 100644 index 0000000..685f102 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P060.wav Binary files differnew file mode 100644 index 0000000..685f102 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P075.wav Binary files differnew file mode 100644 index 0000000..685f102 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P090.wav Binary files differnew file mode 100644 index 0000000..685f102 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P315.wav Binary files differnew file mode 100644 index 0000000..c7cce6e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P330.wav Binary files differnew file mode 100644 index 0000000..93a6b8a --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P345.wav Binary files differnew file mode 100644 index 0000000..efc72bc --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T255_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P000.wav Binary files differnew file mode 100644 index 0000000..8f49078 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P015.wav Binary files differnew file mode 100644 index 0000000..96510f7 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P030.wav Binary files differnew file mode 100644 index 0000000..60b84f4 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P045.wav Binary files differnew file mode 100644 index 0000000..ec995e6 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P060.wav Binary files differnew file mode 100644 index 0000000..e287d0e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P075.wav Binary files differnew file mode 100644 index 0000000..e287d0e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P090.wav Binary files differnew file mode 100644 index 0000000..e287d0e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P315.wav Binary files differnew file mode 100644 index 0000000..01f0921 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P330.wav Binary files differnew file mode 100644 index 0000000..380e707 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P345.wav Binary files differnew file mode 100644 index 0000000..124a534 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T270_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P000.wav Binary files differnew file mode 100644 index 0000000..1a577f3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P015.wav Binary files differnew file mode 100644 index 0000000..ce698bb --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P030.wav Binary files differnew file mode 100644 index 0000000..8d5134f --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P045.wav Binary files differnew file mode 100644 index 0000000..583c6ed --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P060.wav Binary files differnew file mode 100644 index 0000000..583c6ed --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P075.wav Binary files differnew file mode 100644 index 0000000..583c6ed --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P090.wav Binary files differnew file mode 100644 index 0000000..583c6ed --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P315.wav Binary files differnew file mode 100644 index 0000000..7b1b43b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P330.wav Binary files differnew file mode 100644 index 0000000..e9ed7ed --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P345.wav Binary files differnew file mode 100644 index 0000000..6ce83ed --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T285_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P000.wav Binary files differnew file mode 100644 index 0000000..b4ea6bf --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P015.wav Binary files differnew file mode 100644 index 0000000..76d5b71 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P030.wav Binary files differnew file mode 100644 index 0000000..04ee003 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P045.wav Binary files differnew file mode 100644 index 0000000..22d7413 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P060.wav Binary files differnew file mode 100644 index 0000000..1b35018 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P075.wav Binary files differnew file mode 100644 index 0000000..2f55df8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P090.wav Binary files differnew file mode 100644 index 0000000..2f55df8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P315.wav Binary files differnew file mode 100644 index 0000000..7bcc8a4 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P330.wav Binary files differnew file mode 100644 index 0000000..a3bacf3 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P345.wav Binary files differnew file mode 100644 index 0000000..bdfba2d --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T300_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P000.wav Binary files differnew file mode 100644 index 0000000..719320c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P015.wav Binary files differnew file mode 100644 index 0000000..5d366fc --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P030.wav Binary files differnew file mode 100644 index 0000000..e10e88b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P045.wav Binary files differnew file mode 100644 index 0000000..ecb4b50 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P060.wav Binary files differnew file mode 100644 index 0000000..ecb4b50 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P075.wav Binary files differnew file mode 100644 index 0000000..ecb4b50 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P090.wav Binary files differnew file mode 100644 index 0000000..ecb4b50 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P315.wav Binary files differnew file mode 100644 index 0000000..35c44d4 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P330.wav Binary files differnew file mode 100644 index 0000000..8fe859b --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P345.wav Binary files differnew file mode 100644 index 0000000..3e44b83 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T315_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P000.wav Binary files differnew file mode 100644 index 0000000..e878220 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P015.wav Binary files differnew file mode 100644 index 0000000..7628cbc --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P030.wav Binary files differnew file mode 100644 index 0000000..7c4430c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P045.wav Binary files differnew file mode 100644 index 0000000..55e3c5e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P060.wav Binary files differnew file mode 100644 index 0000000..563313e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P075.wav Binary files differnew file mode 100644 index 0000000..563313e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P090.wav Binary files differnew file mode 100644 index 0000000..563313e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P315.wav Binary files differnew file mode 100644 index 0000000..3eccc16 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P330.wav Binary files differnew file mode 100644 index 0000000..fd3f5e1 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P345.wav Binary files differnew file mode 100644 index 0000000..5937c59 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T330_P345.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P000.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P000.wav Binary files differnew file mode 100644 index 0000000..99dc851 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P000.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P015.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P015.wav Binary files differnew file mode 100644 index 0000000..28994d5 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P015.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P030.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P030.wav Binary files differnew file mode 100644 index 0000000..beb24a2 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P030.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P045.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P045.wav Binary files differnew file mode 100644 index 0000000..f840c59 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P045.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P060.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P060.wav Binary files differnew file mode 100644 index 0000000..f840c59 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P060.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P075.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P075.wav Binary files differnew file mode 100644 index 0000000..f840c59 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P075.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P090.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P090.wav Binary files differnew file mode 100644 index 0000000..f840c59 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P090.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P315.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P315.wav Binary files differnew file mode 100644 index 0000000..68baa8e --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P315.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P330.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P330.wav Binary files differnew file mode 100644 index 0000000..6cb01b8 --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P330.wav diff --git a/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P345.wav b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P345.wav Binary files differnew file mode 100644 index 0000000..b2ae88c --- /dev/null +++ b/WebCore/platform/audio/resources/IRC_Composite_C_R0195_T345_P345.wav |