Sunday, November 13, 2011

DSO-5200A SDK Modification FFT




Download the SDK from the Hantek Website:
DSO5200A_SDK.rar

This code was imported to Visual Studio 2008 to compile the code the MFC (microsoft foundation class) api will need to be imported from the Windows WDK. How to Download the WDK

VCDlg.cpp will need to be modified with the following code:
//start snippet        
int N=10256,M=5128;
 double data[20513],fdata[10129];
 int disp[500];
 double data1[10257];
 double data2[10257];
 double data3[10257];
 
 for(int n=0;n<N;n++){
  data1[n]=Ch1.HardwareData[n];
 }
 
 
 
 
 double data4[500];
 double ratio=10256.0/1000.0; //screen size to data size ratio
 
 

 double window[10257];
 double sum=0.0;
//////////////////Calculate the Window Function values into an array and
// calculate the sum of the input data
for(int i=0;i<N;i++){
  window[i]=0.5*(1-cos(2.0*M_PI*double(i)/double(N-1)));
  sum+=double(Ch1.HardwareData[i]);
 }

 double avg=sum/double(N);//determine average and adjust input signal
 for(int i=0;i<N;i++){data3[i]=double(Ch1.HardwareData[i])-avg;}
 
 //output to screen input multiplied by the Window Function
for(int q=0;q<10256;q++){
  m_dcImg.SelectObject(bluepen);
  m_dcImg.LineTo(int(double(q)/ratio),200+int(window[q]*data3[q]));
 }


 /////////Take Orignal Signal and Apply a Window Function////////
 for(int i=0;i<N;i++){
  data[2*i]=window[i]*data3[i]/1024.0;
  data[2*i+1]=0.0;
 }///////////////////////////////////////////////////////////////
//apply the fourier transform
four1(data,8192);
//data is complex output: c = data[j]+data[j+1]i
//calculate the amplitude of the complex data and store in fdata.
for(int j=0;j<8192;j++)fdata[j]=sqrt(data[2*j+1]*data[2*j+1]+data[2*j]*data[2*j]);
 double ratio2=4096.0/2000.0;//set ratio for frequency graph
 for(int k=0;k<2048;k++){
  
  m_dcImg.SetPixel(int(double(k)/ratio2),fdata[k],RGB(0,255,0));//draw pixels 
  m_dcImg.SelectObject(redpen);
  m_dcImg.LineTo(int(double(k)/ratio2),fdata[k]);//draw red lines
 }
//end snippet
//////////////////fourier transform algorithm///////////////////////////
////////////////////////////////////////////////////////////////////////
void four1(double* data, unsigned long nn)
{
    unsigned long n, mmax, m, j, istep, i;
    double wtemp, wr, wpr, wpi, wi, theta;
    double tempr, tempi;
 
    // reverse-binary reindexing
    n = nn<<1;
    j=1;
    for (i=1; i<n; i+=2) {
        if (j>i) {
   
            tempr=data[j-1];data[j-1]=data[i-1]; data[i-1]=tempr;
            tempr=data[j];data[j]=data[i]; data[i]=tempr;
        }
        m = nn;
        while (m>=2 && j>m) {
            j -= m;
            m >>= 1;
        }
        j += m;
    };
 
    // here begins the Danielson-Lanczos section
    mmax=2;
    while (n>mmax) {
        istep = mmax<<1;
        theta = -(2*M_PI/mmax);
        wtemp = sin(0.5*theta);
        wpr = -2.0*wtemp*wtemp;
        wpi = sin(theta);
        wr = 1.0;
        wi = 0.0;
        for (m=1; m < mmax; m += 2) {
            for (i=m; i <= n; i += istep) {
                j=i+mmax;
                tempr = wr*data[j-1] - wi*data[j];
                tempi = wr * data[j] + wi*data[j-1];
 
                data[j-1] = data[i-1] - tempr;
                data[j] = data[i] - tempi;
                data[i-1] += tempr;
                data[i] += tempi;
            }
            wtemp=wr;
            wr += wr*wpr - wi*wpi;
            wi += wi*wpr + wtemp*wpi;
        }
        mmax=istep;
    }
}



Wednesday, August 17, 2011

Copper Steel Plate Battery using Rochelle Salt and Cotton Wool

In reference to http://docsfreelunch.blogspot.com/ . Doc mentions a honey cotton wool and copper zinc plates as a good starter point and the low power circuit is handy.

So I built a rochelle salt ,copper and steel plated battery with cotton wool insulation.

The rochelle salts is made by mixing sodium carbonate and creme of tartar. Firstly heat gently vinegar and add slowly the sodium carbonate. Allow enough sodium carbonate to be soluble. Add the creme of tartar until no longer solubable. Cool down after the mixture has thickened.Place cotton wool  on a steel plate and pour mixture on the cotton wool. Press the copper plate on top and allow to cool. Once cooled ready to measure the voltage.
Here is a picture of the battery measuring 964 millivolts with a capacitor in series. The capacitor had no charge before attached to the battery. Measuring 20 micro amps puts this battery at about 18-15 micro watts.

Wednesday, July 13, 2011

Digital Oscilloscope Readings of Dr Jones Circuit


This new circuit uses a darlington pair of bc547 Low Noise Transistors 50V at 100mA. I am measuring the voltage across a 1 ohm resistor in the ground loop between the battery and the circuit ground. I am using a variable capacitor 50-150pF as well as a 500K ohm variable resistor. The toroid is wound approx 15 turns triple wired the extra winding provides the green led. The Green trace measures the input power. The Yellow trace measure the output voltage across the green led.




This circuit operates at 208kHz and is consuming on average 15-20 milliwatts. The output waveform is approximately 10V peak-to-peak. I am currently constructing a diode bridge to measure the output power.


It turns out that i was measuring the input power incorrectly.
I tried using two similar 1.7 ohm resistors and connected the diode bridge.



The yellow trace represents the output power. Green is the input power.
I must say this looks like an overunity.

Monday, July 4, 2011

Clauss Turtur Zero Point Simulation

Clauss Turtur has written a paper on the zero point energy using mathematical modelling.














The simulation uses a diametric cylinder magnet.
I have replicated the simulation in scilab.


Period: 0.000277 seconds Frequency: 22691.508773
Inductance: 0.37Mass: 0.37 Inertia: 0.00028345

n=600.0;//coil turns
diacoil=0.09;//coil dia
Bo=6.7;//field strength
lcoil=0.01;//length coil
C=0.0053E-6;//capacitance
rm=0.039;//radius magnet
diawire=0.001;//diameter wire
tmag=0.01//thickness of magnet
muo=%pi*4E-7;
epo=8.854E-12;
rho_mag=7.8E3;
A=diacoil*diacoil;
L=muo*A*n*n/lcoil;
fosc=1/sqrt(L*C);
Period=2*%pi/fosc;
printf("Period: %f seconds Frequency: %f\n",Period,fosc);
rho_wire=1.7E-8;
R=200;
Rload=28;
T=20000;
Vc=0;
Q(1)=C*Vc;
ddQ(1)=0;
dQ(1)=0;
phi(1)=0;
dphi(1)=900*%pi;
ddphi(1)=0;
dt=0.000005;
printf("Inductance: %.2f",L);
mass=%pi*rm*rm*tmag*rho_mag;
J=0.5*mass*rm*rm;
printf("Mass: %.2f Inertia: %.8f\n",mass,J);
for t=2:1:T
    
    ddQ(t)=-Q(t-1)/(L*C)-(R+Rload)/L*dQ(t-1);
    ddQ(t)=ddQ(t)+n*Bo*A*sin(phi(t-1))*dphi(t-1)/L;
    
    dQ(t)=dQ(t-1)+(ddQ(t)-R/L*dQ(t-1))*dt;
    Q(t)=Q(t-1)+dQ(t)*dt;
    
    ddphi(t)=-Bo*n*dQ(t)*A/J*sin(phi(t-1)); //torque
    dphi(t)=dphi(t-1)+ddphi(t)*dt;
    phi(t)=phi(t-1)+dphi(t)*dt;
end



The simulation graphs:

3amps Peak-Peak


The magnet is rotating in reverse at -450rpm so an increase of speed will increase to the negative.

Simulation is increasing at 228 ohms resistance any higher the system will slow down.
The trick is to wind the coil bifilar to amplify the Inductance while in keeping the resistance of the coil down as low as possible to achieve over-unity.
Another method would be to use a stronger magnet or higher initial speeds.


Sunday, June 5, 2011

Joule Thief Over Unity Ciruit


The replication following is a circuit derived from Dr. Steven E. Jones joule thief circuit outlined in Figure 1.

Figure 1 Dr Jones Joule Thief Circuit                    

 Figure 2 Shows the toroid which has been bifilar wound 19 times.
The Rb chosen was 2k ohms. R0 was set to 5-10Kohms.Cb was set too approx 150pF using spare parts from a old TV set. The Transistor is a BC548 standard general use low power.

The Circuit is Connected to a 6V battery the battery reading was close to 5.99 when read with a DVM.
  The circuit input current is measured by a 1.5ohm 1/2 watt Resistor. I measured this with the DVM at 65.5mV   65.5/1.5=43.67mA
Power is measured by Pi=VI=6x43.7=262milliWatts.

I then connected a 20-led bulb in parallel to the 10k Load Resistor. Also I attached a 10ohm current measuring resistor. With the DVM I measured this input power again 71.9mV. The current is 71.9/1.5=47.93mA. Pi2=6x48=288 milliwatts.


 Finally I measured the ouput current through the lamp. A reading above of 8.04Volts. This however is an AC signal half wave rectified so this will give us the average power through which is acceptable.
The DVM reading from the sense resistor was 96mV. Current becomes 96/10=9.6mA. Po=8.04x9.6=77.2milliwatts.


efficiency n=Po/(Pi2-Pi)=77.2/(288-262)=77.2/26=2.96







Saturday, April 16, 2011

Hidro SouthEast Queensland Gravity Generators 50MW for 3.75M$AU

http://peswiki.com/index.php/Directory:_Hidro_--_Water_Pressures_Energy_Conversion_(WAPEC)

Hidro looks to be a method of extraction of energy from gravity using the change in pressure of water.
I Look forward to hearing of developments in extracting energy from gravity. Gravity has a much better capacity to supply safely and long term as force is proportional to inverse distance squared. Current methods of linear (VP/T) ambient temperature heat exchange ie modern combustion can not sustain the allowable limits of vehicles and industry. Gravity has a much larger availability for extraction from the environment than temperature heat exchanged to the atmosphere and is safer environmentally.
I am curious to see if Hidro becomes open source at some stage. I gather that the "energy must be free" hypothesis must be true for humanity to become sustainable.

Tuesday, April 12, 2011

Multi Dipole Magnetic Simulation

Introduction

Multi Dipole Simulation of two bar magnets one attached to a wheel the other to a fixed point external to the wheel. Each magnet consists of 5 dipoles at 1cm distance apart for a total of 5cm length per magnet. The magnets are at 0 degrees and 180 degrees respectively.
The strength of the magnets are 0.01 Amperes per meter squared(A/m^2).

Multi Dipole simulation omega=180 degrees phi=0
Disk Mass 1.2kg 25cm in diameter
Bar Magnets Length 5cm
Dipole Length 1cm
Added Friction from normal of force


Program Code



N=5000;
Kfriction=0.01;
m=0.01;
M=0.01;
R=0.25;

Uo=4e-7*%pi;
L=0.01;
I=2;
J=2;
d=(I+J)*L+0.05;
phi=0.0*%pi;
omega=1.0*%pi;
rot_v=0.0;
dt=0.1;
mass=1.2;
theta=1.95*%pi;
for n=1:1:N
    m1=[m*cos(theta+phi) m*sin(theta+phi)];
    m2=[M*cos(omega) M*sin(omega)];
    Fx=0.0;
    Fy=0.0;
    
    for i=-I:1:I
        for j=-J:1:J
            p1x=R*cos(theta)+j*L*cos(theta+phi);
            p1y=R*sin(theta)+j*L*sin(theta+phi);
            p2x=R+d-L*i*cos(omega);
            p2y=L*i*sin(omega);
            
            r=[p2x-p1x p2y-p1y];
            v=(3*Uo/(4*%pi*sqrt(sum(r^2))^5)*(sum(m1.*r)*m2+sum(m2.*r)*m1+sum(m1.*m2)*r-5.0*sum(m1.*r)*sum(m2.*r)/sum(r^2)*r));
            Fx=Fx+v(1);
            Fy=Fy+v(2);
           
        end
    end
    rproj=[-sin(theta) cos(theta)];
    rnorm=[cos(theta) sin(theta) ];
    Ffr=abs(Kfriction*sum([Fx Fy].*rnorm));
    Frot=sum([Fx Fy].*rproj);
    Fsign=Frot/abs(Frot);
    F=Frot-Fsign*Ffr;
    rot_v=rot_v+F*dt/(R*mass);
    theta=theta+rot_v*dt;
    th(n)=theta*180.0/%pi;
    
end


Conculsion
 Wheel is Oscillating back and forth

Thursday, March 17, 2011

Magniwork Is Definitely a Scam

The fraudulent system Magniwork is preventing legitimate magnet motors from entering the market. Buyers beware any system that claims to have a working magnet motor please take heed. The problem with this scam lies mainly in the premise that magnet motors do work though the exact nature of the configuration may be difficult to construct. Therefore any site claiming to have plans and DIY cannot produce a certified device that is backed by industry.
Please Do not click on any of the Magniwork advertisements and beware of web sites that have too many ads.

Thank You

Tuesday, March 15, 2011

Double Pendulum

A Double Pendulum produces a chaotic output that is unstable in an ideal sense. So it makes sense that two double oscillating forces produced one from gravity and then other from magnetism can produce an over unity reaction..

Gravity meets Magnetism to produce free energy

Gravity vs Magnetism
Cluass Turtur Published a paper [1] where he mentions double oscillations and the way to produce free energy. Here the oscillators are gravity oscillation and magnetic oscillation. When used in tandem produces energy.

The following video features a machine that harnesses both magnetic and gravitational energy.