I have the following code: sampling_rate=128 N = sampling_rate _f, t, Sxx = signal.spectrogram(_signal, sampling_rate, nperseg=N, nfft=N, noverlap=N-1, mode="co
If I have two arrays that are identical except for a shift: import numpy as np from scipy import signal x = [4,4,4,4,6,8,10,8,6,4,4,4,4,4,4,4,4,4,4,4,4,4,4] y =
trying to fit some sine wave to data i collected. But Amplitude and Frequency are way off. Any suggestions? x=[0,1,3,4,5,6,7,11,12,13,14,15,16,18,20,21,22,24,26
I'm trying to constrain the function with the use of MCMC methods (emcee) without the analytical form of this function. I'm using the odeint to obtain the funct
I have another question, is there a package that interpolates precipitation data taking into account mountains and oceans? I have so far used Numpy and Basemap
I would like to use scipy.fftpack.fft (and rfft) inside a multiprocessing structure, I have observed significant performances losses due to an apparent incompat
It looks like scipy.spatial.distance.cdist cosine similariy distance: link to cos distance 1 1 - u*v/(||u||||v||) is different from sklearn.metrics.pairwis
I'm trying to compute the following definite integral: Integral I want to compute: where rho_ch is and a = 3.66 * 10^(-15) m (in meters) b = 0.54 * 10^(-15) m
As a part of multi-start optimization, I am running differential evolution (DE), the output of which I feed as initial values to scipy minimization with SLSQP (
At the Top "right", there is the 2D-density plot of the recorded data (actual), fewer in number. On the top-left is the interpolated data (thin-plate), i.e. la
There are lots of constraints which I will use in optimization using scipy; so I need to generate the constraints by loop. Below there's a sample of my constrai
The installation on the m1 chip for the following packages: Numpy 1.21.1, pandas 1.3.0, torch 1.9.0 and a few other ones works fine for me. They also seem to wo
I am trying to find all objects detected in difference of frames, I thougt this would give a list of each area detected in the threshold, but find_objects is gi
Hello I am following this example for labelling connected components of an image. I understand how to measure and label the blobs seen in this link. However how
I was using the CVXPY library in Python, trying to solve a particular optimization problem. import cvxpy as cp import numpy as np from scipy.stats import norm
Essentially, I have a CSV file full of compass bearings in radians from 0 to 2pi and attached timestamps that looks something like this: time, bearing 0.36,0.01
I have a pair of two-dimensional arrays from a gridded dataset (in GeoTIFF format), both with the exact same resolution and number of rows/columns. Suppose Arra
I have a huge linprog problem of almost 1k variables and restrictions. I can calculate the solution with scipy.optimize.linprog(method='simplex') but I need sha
I am using scipy.signal to calculate the width of the different peaks. I have 100 values wrt to different time points. I am using following code to calculate th
I am trying to write code which generates a sound file based on a series of frequencies I give it, but I have reached a point where compiling the arrays of inte