Editing
Thunderstorm Generator
(section)
From FusionGirl Wiki
Jump to navigation
Jump to search
Warning:
You are not logged in. Your IP address will be publicly visible if you make any edits. If you
log in
or
create an account
, your edits will be attributed to your username, along with other benefits.
Anti-spam check. Do
not
fill this in!
= Math, Science & Engineering = {| class="wikitable" |+ Equations for Thunderstorm Generator Science and Engineering ! Discipline !! Equation !! Description |- | Thermodynamics || <math>Q = mc\Delta T</math> || <math>Q</math> is heat transferred, <math>m</math> is mass, <math>c</math> is specific heat, and <math>\Delta T</math> is temperature change. |- | || <math>\eta = \frac{W_{\text{out}}}{Q_{\text{in}}}</math> || Efficiency of the heat engine, where <math>\eta</math> is efficiency, <math>W_{\text{out}}</math> is work output, and <math>Q_{\text{in}}</math> is heat input. |- | || <math>PV = nRT</math> || Ideal gas law, where <math>P</math> is pressure, <math>V</math> is volume, <math>n</math> is number of moles, <math>R</math> is the gas constant, and <math>T</math> is temperature. |- | || <math>\Delta S = \int \frac{dQ}{T}</math> || Entropy change equation, where <math>\Delta S</math> is change in entropy, <math>dQ</math> is heat transfer, and <math>T</math> is temperature. |- | Fluid Mechanics || <math>P + \frac{1}{2}\rho v^2 + \rho gh = \text{constant}</math> || Bernoulli's equation for steady, incompressible flow along a streamline, where <math>P</math> is pressure, <math>\rho</math> is density, <math>v</math> is velocity, <math>g</math> is acceleration due to gravity, and <math>h</math> is height. |- | || <math>F = \rho A v^2</math> || Drag force equation, where <math>F</math> is drag force, <math>\rho</math> is fluid density, <math>A</math> is reference area, and <math>v</math> is velocity. |- | || <math>\tau = \mu \frac{du}{dy}</math> || Shear stress equation, where <math>\tau</math> is shear stress, <math>\mu</math> is dynamic viscosity, <math>u</math> is velocity, and <math>y</math> is distance perpendicular to the direction of flow. |- | || <math>\nabla \cdot \mathbf{v} = 0</math> || Continuity equation for incompressible flow, where <math>\nabla</math> is the divergence operator and <math>\mathbf{v}</math> is the velocity vector. |- | Electromagnetism || <math>F = q(E + v \times B)</math> || Lorentz force equation, where <math>F</math> is force, <math>q</math> is charge, <math>E</math> is electric field, <math>v</math> is velocity, and <math>B</math> is magnetic field. |- | || <math>\Phi_B = \int \int B \cdot dA</math> || Magnetic flux equation, where <math>\Phi_B</math> is magnetic flux and <math>B</math> is magnetic field. |- | || <math>\nabla \cdot \mathbf{E} = \frac{\rho}{\varepsilon_0}</math> || Gauss's law for electric fields, where <math>\nabla</math> is the divergence operator, <math>\mathbf{E}</math> is the electric field vector, <math>\rho</math> is charge density, and <math>\varepsilon_0</math> is the vacuum permittivity. |- | || <math>\nabla \times \mathbf{E} = -\frac{\partial \mathbf{B}}{\partial t}</math> || Faraday's law of electromagnetic induction, where <math>\nabla</math> is the curl operator, <math>\mathbf{E}</math> is the electric field vector, <math>\mathbf{B}</math> is the magnetic field vector, and <math>t</math> is time. |- | Quantum Mechanics || <math>E = hf</math> || Planck's equation, where <math>E</math> is energy, <math>h</math> is Planck's constant, and <math>f</math> is frequency. |- | || <math>E = \frac{mv^2}{2}</math> || Kinetic energy equation, where <math>E</math> is energy, <math>m</math> is mass, and <math>v</math> is velocity. |- | || <math>\Delta x \Delta p \geq \frac{h}{4\pi}</math> || Heisenberg uncertainty principle, where <math>\Delta x</math> is uncertainty in position, <math>\Delta p</math> is uncertainty in momentum, and <math>h</math> is Planck's constant. |- | || <math>\psi(x) = Ae^{ikx} + Be^{-ikx}</math> || Wave function of a particle, where <math>\psi(x)</math> is the wave function, <math>A</math> and <math>B</math> are constants, <math>k</math> is the wave number, and <math>x</math> is position. |- | || <math>\hat{H}\psi = E\psi</math> || Schrödinger equation, where <math>\hat{H}</math> is the Hamiltonian operator, <math>\psi</math> is the wave function, and <math>E</math> is energy. |} ==== Here's a detailed instruction subsection for using each of the equations in the context of their usefulness to Thunderstorm Generator Science and Engineering: ==== == Detailed Instruction for Using Equations in Thunderstorm Generator Science and Engineering == === Heat Transfer Equation (Thermodynamics) === * '''Equation:''' <math>Q = mc\Delta T</math> * '''Description:''' This equation is crucial for understanding the heat transfer within the Thunderstorm Generator components. It helps in calculating the amount of heat transferred when there is a temperature difference (\(\Delta T\)) between the components with mass \(m\) and specific heat \(c\). * '''Usefulness:''' Use this equation to analyze the heat exchange processes within the Thunderstorm Generator, such as in heat exchangers or during combustion. <syntaxhighlight lang="c"> // Heat Transfer Equation (Thermodynamics) double heat_transfer(double m, double c, double delta_T) { return m * c * delta_T; } </syntaxhighlight> === Efficiency Equation (Thermodynamics) === * '''Equation:''' <math>\eta = \frac{W_{\text{out}}}{Q_{\text{in}}}</math> * '''Description:''' This equation determines the efficiency of the Thunderstorm Generator in converting input heat (\(Q_{\text{in}}\)) into useful work output (\(W_{\text{out}}\)). * '''Usefulness:''' Use this equation to assess the performance and effectiveness of the Thunderstorm Generator in converting thermal energy into mechanical work. <syntaxhighlight lang="c"> // Efficiency Equation (Thermodynamics) double efficiency(double W_out, double Q_in) { return W_out / Q_in; } </syntaxhighlight> === Ideal Gas Law (Thermodynamics) === * '''Equation:''' <math>PV = nRT</math> * '''Description:''' This equation relates the pressure, volume, temperature, and amount of gas in a system. It's essential for understanding the behavior of gases within the Thunderstorm Generator. * '''Usefulness:''' Apply this equation to analyze the properties of gases involved in the operation of the Thunderstorm Generator, such as the behavior of hydrogen and oxygen. <syntaxhighlight lang="c"> // Efficiency Equation (Thermodynamics) double efficiency(double W_out, double Q_in) { return W_out / Q_in; } </syntaxhighlight> === Entropy Change Equation (Thermodynamics) === * '''Equation:''' <math>\Delta S = \int \frac{dQ}{T}</math> * '''Description:''' This equation describes the change in entropy during a thermodynamic process, indicating the direction and extent of energy dispersal or dissipation. * '''Usefulness:''' Use this equation to analyze the entropy changes within the Thunderstorm Generator, providing insights into the efficiency and irreversibility of energy conversion processes. <syntaxhighlight lang="c"> // Entropy Change Equation (Thermodynamics) double entropy_change(double dQ, double T) { return dQ / T; } </syntaxhighlight> === Bernoulli's Equation (Fluid Mechanics) === * '''Equation:''' <math>P + \frac{1}{2}\rho v^2 + \rho gh = \text{constant}</math> * '''Description:''' This equation describes the conservation of energy along a streamline in a fluid flow, relating pressure, velocity, and elevation. * '''Usefulness:''' Apply this equation to analyze fluid flow phenomena within the Thunderstorm Generator, such as in fluid pumps or turbines. <syntaxhighlight lang="c"> // Bernoulli's Equation (Fluid Mechanics) double bernoullis_equation(double P, double rho, double v, double g, double h) { return P + 0.5 * rho * v * v + rho * g * h; } </syntaxhighlight> === Mass Balance Equation (Chemical Engineering) === * '''Equation:''' <math>\frac{d}{dt}\left(\rho V\right) = \sum \dot{m}_{\text{in}} - \sum \dot{m}_{\text{out}}</math> * '''Description:''' This equation represents the conservation of mass for a control volume, accounting for mass flow rates into and out of the system. * '''Usefulness:''' Use this equation to ensure mass conservation in the design and operation of components like reactors or separators within the Thunderstorm Generator. <syntaxhighlight lang="c"> // Mass Balance Equation (Chemical Engineering) double mass_balance(double rho, double V, double sum_dot_m_in, double sum_dot_m_out) { return (sum_dot_m_in - sum_dot_m_out) / V; } </syntaxhighlight> === Conservation of Energy Equation (Fluid Mechanics) === * '''Equation:''' <math>\frac{D}{Dt}\left(\frac{1}{2}V^2 + gz + \frac{P}{\rho}\right) = \dot{Q} - \dot{W} + \frac{D}{Dt}\left(\frac{1}{2}V^2 + gz + \frac{P}{\rho}\right)_{\text{viscous}}</math> * '''Description:''' This equation states the conservation of total energy for a fluid particle in a flow field, considering heat transfer, work done, and viscous effects. * '''Usefulness:''' Apply this equation to analyze energy changes in fluid flow processes within the Thunderstorm Generator, accounting for heat transfer and work done by the fluid. <syntaxhighlight lang="c"> // Conservation of Energy Equation (Fluid Mechanics) double energy_conservation(double Q_dot, double W_dot, double viscous_term) { return Q_dot - W_dot + viscous_term; } </syntaxhighlight> === Navier-Stokes Equation (Fluid Mechanics) === * '''Equation:''' <math>\rho\left(\frac{\partial \mathbf{v}}{\partial t} + (\mathbf{v} \cdot \nabla)\mathbf{v}\right) = -\nabla p + \nabla \cdot \mathbf{T} + \rho \mathbf{g}</math> * '''Description:''' This equation describes the motion of fluid substances, including viscous effects, acceleration, and external forces. * '''Usefulness:''' Use this equation to model fluid flow phenomena within complex geometries of Thunderstorm Generator components, accounting for both inertial and viscous effects. === Maxwell's Equations (Electromagnetism) === * '''Equations:''' ** <math>\nabla \cdot \mathbf{E} = \frac{\rho}{\varepsilon_0}</math> ** <math>\nabla \cdot \mathbf{B} = 0</math> ** <math>\nabla \times \mathbf{E} = -\frac{\partial \mathbf{B}}{\partial t}</math> ** <math>\nabla \times \mathbf{B} = \mu_0\mathbf{J} + \mu_0\varepsilon_0\frac{\partial \mathbf{E}}{\partial t}</math> * '''Description:''' These equations describe how electric and magnetic fields interact with matter and each other. * '''Usefulness:''' Apply Maxwell's equations to analyze electromagnetic phenomena within the Thunderstorm Generator, such as plasma generation and control using magnetic fields. === Schrödinger Equation (Quantum Mechanics) === * '''Equation:''' <math>i\hbar \frac{\partial}{\partial t} \Psi(\mathbf{r},t) = \hat{H}\Psi(\mathbf{r},t)</math> * '''Description:''' This equation governs the behavior of quantum mechanical systems, describing how the wavefunction of a physical system evolves over time. * '''Usefulness:''' While primarily applicable at the atomic and subatomic levels, understanding the principles of quantum mechanics can inform the design and operation of nanoscale components within the Thunderstorm Generator. === Continuity Equation (Fluid Mechanics) === * '''Equation:''' <math>\frac{\partial \rho}{\partial t} + \nabla \cdot (\rho \mathbf{v}) = 0</math> * '''Description:''' This equation expresses the conservation of mass for a fluid, stating that the rate of change of mass within a control volume is equal to the net flow of mass into or out of the volume. * '''Usefulness:''' Apply this equation to ensure mass conservation in fluid flow processes within the Thunderstorm Generator, such as incompressible flow through conduits or channels. === Wave Equation (Physics) === * '''Equation:''' <math>\frac{\partial^2 u}{\partial t^2} = c^2 \nabla^2 u</math> * '''Description:''' This equation describes the propagation of waves, including sound waves, electromagnetic waves, and mechanical waves. * '''Usefulness:''' Use this equation to analyze wave phenomena within the Thunderstorm Generator, such as acoustic vibrations or electromagnetic radiation. === Ideal Reactor Equation (Chemical Engineering) === * '''Equation:''' <math>\frac{dF_A}{dV} = r_AV</math> * '''Description:''' This equation represents the change in the molar flow rate of a chemical species \(A\) with respect to reactor volume \(V\) in an ideal chemical reactor. * '''Usefulness:''' Apply this equation to model chemical reactions occurring within reactors or chambers of the Thunderstorm Generator, aiding in reactor design and optimization. === Conservation of Momentum Equation (Fluid Mechanics) === * '''Equation:''' <math>\rho \frac{D\mathbf{v}}{Dt} = -\nabla p + \mu \nabla^2 \mathbf{v} + \rho \mathbf{g}</math> * '''Description:''' This equation expresses Newton's second law for fluid flow, accounting for pressure gradients, viscous forces, and gravitational forces. * '''Usefulness:''' Use this equation to analyze the motion and behavior of fluids within the Thunderstorm Generator, accounting for forces and stresses exerted on the fluid. === Boltzmann Transport Equation (Statistical Mechanics) === * '''Equation:''' <math>\frac{\partial f}{\partial t} + \mathbf{v} \cdot \nabla f + \mathbf{F} \cdot \nabla_v f = \left(\frac{\partial f}{\partial t}\right)_{\text{coll}}</math> * '''Description:''' This equation describes the evolution of the distribution function \(f\) of particles in phase space, considering external forces and collisions. * '''Usefulness:''' While primarily used in semiconductor physics, applying statistical mechanics principles can aid in understanding and optimizing particle transport processes within the Thunderstorm Generator. === Diffusion Equation (Chemical Engineering) === * '''Equation:''' <math>\frac{\partial C}{\partial t} = D\nabla^2 C</math> * '''Description:''' This equation describes the diffusion of chemical species in a medium, where \(C\) is concentration and \(D\) is the diffusion coefficient. * '''Usefulness:''' Apply this equation to analyze the diffusion of reactants or products within the Thunderstorm Generator, aiding in understanding mass transport phenomena. === Poisson's Equation (Electromagnetism) === * '''Equation:''' <math>\nabla^2 \Phi = -\frac{\rho}{\varepsilon_0}</math> * '''Description:''' This equation relates the electric potential (\(\Phi\)) to the charge density (\(\rho\)) in electrostatic fields. * '''Usefulness:''' Use Poisson's equation to model electrostatic phenomena within the Thunderstorm Generator, such as electric field generation and control. === Laplace's Equation (Physics) === * '''Equation:''' <math>\nabla^2 \Phi = 0</math> * '''Description:''' Laplace's equation describes scalar fields where there are no sources or sinks. * '''Usefulness:''' Apply this equation to analyze steady-state electrostatic or gravitational fields within the Thunderstorm Generator, aiding in field distribution optimization. === Newton's Law of Universal Gravitation (Physics) === * '''Equation:''' <math>F = G\frac{m_1m_2}{r^2}</math> * '''Description:''' This equation describes the gravitational force between two objects with masses \(m_1\) and \(m_2\), separated by a distance \(r\). * '''Usefulness:''' While primarily applicable to celestial mechanics, understanding gravitational forces can be useful in certain Thunderstorm Generator designs involving large masses or gravitational effects. <syntaxhighlight lang="c"> // Newton's Law of Universal Gravitation (Physics) double newtons_law_of_gravitation(double G, double m1, double m2, double r) { return G * m1 * m2 / (r * r); } </syntaxhighlight> === Fourier Transform (Mathematics) === * '''Equation:''' <math>\hat{f}(\xi) = \int_{-\infty}^{\infty} f(x)e^{-2\pi i \xi x} \, dx</math> * '''Description:''' The Fourier transform decomposes a function of time (or space) into its constituent frequencies. * '''Usefulness:''' Apply the Fourier transform to analyze the frequency components of signals or phenomena within the Thunderstorm Generator, aiding in signal processing or spectral analysis. === Laplace Transform (Mathematics) === * '''Equation:''' <math>\mathcal{L}\{f(t)\} = \int_0^\infty e^{-st} f(t) \, dt</math> * '''Description:''' The Laplace transform converts a function of time into a function of a complex variable \(s\), often used to solve differential equations. * '''Usefulness:''' Use the Laplace transform to analyze dynamic responses or transient behavior within the Thunderstorm Generator, aiding in system dynamics and control. === Conservation of Charge (Electromagnetism) === * '''Equation:''' <math>\nabla \cdot \mathbf{E} = \frac{\rho}{\varepsilon_0}</math> * '''Description:''' This equation expresses Gauss's law, stating that the electric flux out of any closed surface is proportional to the total electric charge enclosed by the surface. * '''Usefulness:''' Apply this equation to ensure charge conservation and analyze electric field distributions within Thunderstorm Generator components. === Gas Law (Thermodynamics) === * '''Equation:''' <math>PV = nRT</math> * '''Description:''' The ideal gas law relates the pressure (\(P\)), volume (\(V\)), amount of substance (\(n\)), and temperature (\(T\)) of a gas. * '''Usefulness:''' Use this equation to analyze the behavior of gases within the Thunderstorm Generator, aiding in the design and optimization of gas-handling systems. === Conservation of Momentum (Physics) === * '''Equation:''' <math>F = \frac{dp}{dt}</math> * '''Description:''' This equation expresses Newton's second law of motion, stating that the net force acting on an object is equal to the rate of change of its momentum. * '''Usefulness:''' Apply this equation to analyze momentum transfer and fluid dynamics within the Thunderstorm Generator, aiding in the design of propulsion or fluid handling systems. === Euler's Equation (Fluid Mechanics) === * '''Equation:''' <math>\frac{\partial \mathbf{v}}{\partial t} + (\mathbf{v} \cdot \nabla)\mathbf{v} = -\frac{\nabla p}{\rho} + \mathbf{g}</math> * '''Description:''' Euler's equation describes the motion of an inviscid fluid, relating acceleration to pressure gradients and gravitational forces. * '''Usefulness:''' Use this equation to analyze fluid flow behavior within the Thunderstorm Generator, particularly in regions with high velocities or accelerations. === Reynolds Transport Theorem (Fluid Mechanics) === * '''Equation:''' <math>\frac{D}{Dt}\int_{\Omega(t)} \phi \, dV = \int_{\Omega(t)} \frac{\partial \phi}{\partial t} \, dV + \int_{\partial \Omega(t)} \phi (\mathbf{v} \cdot \mathbf{n}) \, dA</math> * '''Description:''' This theorem relates the change in an extensive property within a control volume to its rate of change and the flux of the property across the control volume boundary. * '''Usefulness:''' Apply this theorem to analyze the transport of mass, momentum, or energy within the Thunderstorm Generator, aiding in the formulation of conservation laws and fluid flow models. === Maxwell-Boltzmann Distribution (Statistical Mechanics) === * '''Equation:''' <math>f(v) = 4\pi \left(\frac{m}{2\pi kT}\right)^{\frac{3}{2}} v^2 e^{-\frac{mv^2}{2kT}}</math> * '''Description:''' This distribution describes the statistical distribution of speeds for particles in a gas at equilibrium. * '''Usefulness:''' Apply the Maxwell-Boltzmann distribution to analyze the distribution of particle velocities within gas-filled regions of the Thunderstorm Generator, aiding in understanding gas behavior and collision frequencies. === Kirchhoff's Law (Electrical Engineering) === * '''Equation:''' <math>\sum V_i = \sum I_j R_j</math> * '''Description:''' Kirchhoff's voltage law states that the sum of the voltages around any closed loop in a circuit is equal to the sum of the products of the currents and resistances in that loop. * '''Usefulness:''' Apply Kirchhoff's law to analyze electrical circuits and systems within the Thunderstorm Generator, aiding in circuit design and troubleshooting. === Coulomb's Law (Electromagnetism) === * '''Equation:''' <math>F = \frac{k|q_1q_2|}{r^2}</math> * '''Description:''' Coulomb's law describes the electrostatic force between two charged particles, where \(k\) is Coulomb's constant, \(q_1\) and \(q_2\) are the magnitudes of the charges, and \(r\) is the distance between them. * '''Usefulness:''' Apply Coulomb's law to analyze electrostatic interactions within the Thunderstorm Generator, aiding in the design and control of electric fields and plasma confinement. === Conservation of Energy (Physics) === * '''Equation:''' <math>\Delta U = Q - W</math> * '''Description:''' This equation expresses the first law of thermodynamics, stating that the change in internal energy of a system is equal to the heat added to the system minus the work done by the system. * '''Usefulness:''' Apply this equation to analyze energy transfers and conversions within the Thunderstorm Generator === Programming Tips for these Equations: === # '''Partial Differential Equations (PDEs) and Integral Transforms''': #* Example: #** <math>\frac{dy}{dx} = -2y </math> #* These equations involve derivatives with respect to multiple independent variables (such as time and space) and may require integration over regions or domains. #* Writing direct functions for these equations is not feasible because they often require solving complex differential equations. #* Instead, numerical methods such as finite difference, finite element, or spectral methods are used to approximate solutions. #* For integral transforms like Fourier or Laplace transforms, libraries or built-in functions in programming languages can be used. #* For these equations, we typically rely on specialized software libraries or tools for numerical simulation. Here's an example of using a hypothetical library <code>libphysics</code> to solve Maxwell's equations:<syntaxhighlight lang="c"> #include <stdio.h> #include <math.h> // Function to solve the differential equation dy/dx = -2y double solve_differential_equation(double x, double y) { return -2 * y; // Example differential equation } int main() { double x0 = 0.0; // Initial x value double y0 = 1.0; // Initial y value double h = 0.1; // Step size // Using Euler's method for numerical integration for (double x = x0; x <= 1.0; x += h) { y0 += h * solve_differential_equation(x, y0); } printf("Approximate solution at x=1: %f\n", y0); return 0; } </syntaxhighlight> # '''Partial Differential Equations (PDEs) like Navier-Stokes, Schrödinger, Wave Equations''': #* Example: #** <math>\frac{\partial T}{\partial t} = \alpha \frac{\partial^2 T}{\partial x^2} </math> #* Equations such as the Navier-Stokes equation for fluid dynamics, the Schrödinger equation for quantum mechanics, and the wave equation for wave propagation are fundamental in physics. #* They describe complex phenomena and cannot be directly solved with simple functions. #* Solving these equations often requires advanced mathematical techniques or numerical methods like finite difference, finite element, or spectral methods. #* Implementations involve discretizing the equations in space and time and solving them iteratively.<syntaxhighlight lang="c"> #include <stdio.h> #define NX 100 // Number of grid points #define NT 100 // Number of time steps #define DX 0.1 // Grid spacing #define DT 0.01 // Time step // Function to initialize the temperature profile void initialize_temperature(double temperature[]) { for (int i = 0; i < NX; i++) { temperature[i] = 0.0; // Initial temperature } } // Function to solve the heat equation using finite difference method void solve_heat_equation(double temperature[]) { double new_temperature[NX]; for (int t = 0; t < NT; t++) { for (int i = 1; i < NX - 1; i++) { new_temperature[i] = temperature[i] + DT * (temperature[i + 1] - 2 * temperature[i] + temperature[i - 1]) / (DX * DX); } for (int i = 1; i < NX - 1; i++) { temperature[i] = new_temperature[i]; } } } int main() { double temperature[NX]; // Initialize temperature profile initialize_temperature(temperature); // Solve the heat equation solve_heat_equation(temperature); // Output the results for (int i = 0; i < NX; i++) { printf("Temperature at position %d: %f\n", i, temperature[i]); } return 0; } </syntaxhighlight> # '''Equations like Maxwell's Equations, Boltzmann Transport Equation''': #* Example: #** <math>\nabla \cdot \mathbf{E} = \frac{\rho}{\varepsilon_0} </math> #* These equations are sets of differential equations that describe fundamental physical principles. #* They involve multiple variables and interactions and cannot be directly represented as simple functions. #* Analyzing these equations typically involves numerical methods, simulations, or specific models tailored to the problem at hand. #* Software packages or libraries dedicated to computational physics or engineering may provide tools for solving these equations.<syntaxhighlight lang="c"> #include <stdio.h> #include "libphysics.h" // Hypothetical library for physics simulations int main() { // Define parameters double rho = 1.0; // Charge density double epsilon_0 = 8.854e-12; // Permittivity of free space // Solve Maxwell's equations double electric_field = solve_maxwells_equations(rho, epsilon_0); // Output the result printf("Electric field: %f\n", electric_field); return 0; } </syntaxhighlight> In practice, specialized software packages like COMSOL, ANSYS, or custom-built simulation tools are often used for solving complex physical equations numerically.
Summary:
Please note that all contributions to FusionGirl Wiki are considered to be released under the Creative Commons Attribution (see
FusionGirl Wiki:Copyrights
for details). If you do not want your writing to be edited mercilessly and redistributed at will, then do not submit it here.
You are also promising us that you wrote this yourself, or copied it from a public domain or similar free resource.
Do not submit copyrighted work without permission!
Cancel
Editing help
(opens in new window)
Navigation menu
Page actions
Page
Discussion
Read
Edit
Edit source
History
Page actions
Page
Discussion
More
Tools
Personal tools
Not logged in
Talk
Contributions
Create account
Log in
Navigation
Main page
Recent changes
Random page
Help about MediaWiki
Search
Tools
What links here
Related changes
Special pages
Page information